GenomicRanges - Representation and manipulation of genomic intervals
The ability to efficiently represent and manipulate genomic annotations and alignments is playing a central role when it comes to analyzing high-throughput sequencing data (a.k.a. NGS data). The GenomicRanges package defines general purpose containers for storing and manipulating genomic intervals and variables defined along a genome. More specialized containers for representing and manipulating short alignments against a reference genome, or a matrix-like summarization of an experiment, are defined in the GenomicAlignments and SummarizedExperiment packages, respectively. Both packages build on top of the GenomicRanges infrastructure.
Last updated 7 days ago
geneticsinfrastructuredatarepresentationsequencingannotationgenomeannotationcoveragebioconductor-packagecore-package
17.85 score 45 stars 1.3k packages 14k scripts 87k downloadsBiostrings - Efficient manipulation of biological strings
Memory efficient string containers, string matching algorithms, and other utilities, for fast manipulation of large biological sequences or sets of sequences.
Last updated 15 days ago
sequencematchingalignmentsequencinggeneticsdataimportdatarepresentationinfrastructurebioconductor-packagecore-package
17.79 score 57 stars 1.2k packages 8.9k scripts 96k downloadsSummarizedExperiment - A container (S4 class) for matrix-like assays
The SummarizedExperiment container contains one or more assays, each represented by a matrix-like object of numeric or other mode. The rows typically represent genomic ranges of interest and the columns represent samples.
Last updated 24 days ago
geneticsinfrastructuresequencingannotationcoveragegenomeannotationbioconductor-packagecore-package
17.03 score 33 stars 1.2k packages 9.5k scripts 82k downloadsGenomeInfoDb - Utilities for manipulating chromosome names, including modifying them to follow a particular naming style
Contains data and functions that define and allow translation between different chromosome sequence naming conventions (e.g., "chr1" versus "1"), including a function that attempts to place sequence names in their natural, rather than lexicographic, order.
Last updated 7 days ago
geneticsdatarepresentationannotationgenomeannotationbioconductor-packagecore-package
16.49 score 31 stars 1.7k packages 1.3k scripts 114k downloadsBiobase - Biobase: Base functions for Bioconductor
Functions that are needed by many other packages or which replace R functions.
Last updated 24 days ago
infrastructurebioconductor-packagecore-package
16.48 score 9 stars 1.8k packages 7.0k scripts 94k downloadsBiocManager - Access the Bioconductor Project Package Repository
A convenient tool to install and update Bioconductor packages.
Last updated 3 months ago
core-services
16.27 score 73 stars 428 packages 2.7k scripts 208k downloadsBiocParallel - Bioconductor facilities for parallel evaluation
This package provides modified versions and novel implementation of functions for parallel evaluation, tailored to use with Bioconductor objects.
Last updated 24 days ago
infrastructurebioconductor-packagecore-package
16.13 score 67 stars 1.1k packages 6.4k scripts 86k downloadsS4Vectors - Foundation of vector-like and list-like containers in Bioconductor
The S4Vectors package defines the Vector and List virtual classes and a set of generic functions that extend the semantic of ordinary vectors and lists in R. Package developers can easily implement vector-like or list-like objects as concrete subclasses of Vector or List. In addition, a few low-level concrete subclasses of general interest (e.g. DataFrame, Rle, Factor, and Hits) are implemented in the S4Vectors package itself (many more are implemented in the IRanges package and in other Bioconductor infrastructure packages).
Last updated 7 days ago
infrastructuredatarepresentationbioconductor-packagecore-package
16.10 score 18 stars 1.8k packages 1.0k scripts 110k downloadsIRanges - Foundation of integer range manipulation in Bioconductor
Provides efficient low-level and highly reusable S4 classes for storing, manipulating and aggregating over annotated ranges of integers. Implements an algebra of range operations, including efficient algorithms for finding overlaps and nearest neighbors. Defines efficient list-like classes for storing, transforming and aggregating large grouped data, i.e., collections of atomic vectors and DataFrames.
Last updated 7 days ago
infrastructuredatarepresentationbioconductor-packagecore-package
16.09 score 22 stars 1.8k packages 2.1k scripts 105k downloadsDelayedArray - A unified framework for working transparently with on-disk and in-memory array-like datasets
Wrapping an array-like object (typically an on-disk object) in a DelayedArray object allows one to perform common array operations on it without loading the object in memory. In order to reduce memory usage and optimize performance, operations on the object are either delayed or executed using a block processing mechanism. Note that this also works on in-memory array-like objects like DataFrame objects (typically with Rle columns), Matrix objects, ordinary arrays and, data frames.
Last updated 7 days ago
infrastructuredatarepresentationannotationgenomeannotationbioconductor-packagecore-package
15.60 score 25 stars 1.2k packages 550 scripts 92k downloadsGenomicAlignments - Representation and manipulation of short genomic alignments
Provides efficient containers for storing and manipulating short genomic alignments (typically obtained by aligning short reads to a reference genome). This includes read counting, computing the coverage, junction detection, and working with the nucleotide content of the alignments.
Last updated 24 days ago
infrastructuredataimportgeneticssequencingrnaseqsnpcoveragealignmentimmunooncologybioconductor-packagecore-package
15.50 score 9 stars 525 packages 3.0k scripts 47k downloadsRsamtools - Binary alignment (BAM), FASTA, variant call (BCF), and tabix file import
This package provides an interface to the 'samtools', 'bcftools', and 'tabix' utilities for manipulating SAM (Sequence Alignment / Map), FASTA, binary variant call (BCF) and compressed indexed tab-delimited (tabix) files.
Last updated 24 days ago
dataimportsequencingcoveragealignmentqualitycontrolbioconductor-packagecore-package
15.41 score 27 stars 569 packages 3.3k scripts 48k downloadsGenomicFeatures - Query the gene models of a given organism/assembly
Extract the genomic locations of genes, transcripts, exons, introns, and CDS, for the gene models stored in a TxDb object. A TxDb object is a small database that contains the gene models of a given organism/assembly. Bioconductor provides a small collection of TxDb objects in the form of ready-to-install TxDb packages for the most commonly studied organisms. Additionally, the user can easily make a TxDb object (or package) for the organism/assembly of their choice by using the tools from the txdbmaker package.
Last updated 15 days ago
geneticsinfrastructureannotationsequencinggenomeannotationbioconductor-packagecore-package
15.39 score 26 stars 340 packages 5.3k scripts 34k downloadsKEGGREST - Client-side REST access to the Kyoto Encyclopedia of Genes and Genomes (KEGG)
A package that provides a client interface to the Kyoto Encyclopedia of Genes and Genomes (KEGG) REST API. Only for academic use by academic users belonging to academic institutions (see <https://www.kegg.jp/kegg/rest/>). Note that KEGGREST is based on KEGGSOAP by J. Zhang, R. Gentleman, and Marc Carlson, and KEGG (python package) by Aurelien Mazurie.
Last updated 24 days ago
annotationpathwaysthirdpartyclientkeggbioconductor-packagecore-package
14.35 score 7 stars 778 packages 696 scripts 66k downloadsAnnotationDbi - Manipulation of SQLite-based annotations in Bioconductor
Implements a user-friendly interface for querying SQLite-based annotation data packages.
Last updated 24 days ago
annotationmicroarraysequencinggenomeannotationbioconductor-packagecore-package
14.16 score 9 stars 770 packages 3.2k scripts 67k downloadsBiocGenerics - S4 generic functions used in Bioconductor
The package defines many S4 generic functions used in Bioconductor.
Last updated 7 days ago
infrastructurebioconductor-packagecore-package
14.04 score 12 stars 2.2k packages 606 scripts 108k downloadsBiocFileCache - Manage Files Across Sessions
This package creates a persistent on-disk cache of files that the user can add, update, and retrieve. It is useful for managing resources (such as custom Txdb objects) that are costly or difficult to create, web resources, and data files used across sessions.
Last updated 24 days ago
dataimportcore-package
13.63 score 12 stars 426 packages 474 scripts 43k downloadsBSgenome - Software infrastructure for efficient representation of full genomes and their SNPs
Infrastructure shared by all the Biostrings-based genome data packages.
Last updated 24 days ago
geneticsinfrastructuredatarepresentationsequencematchingannotationsnpbioconductor-packagecore-package
13.17 score 9 stars 268 packages 1.1k scripts 25k downloadsAnnotationHub - Client to access AnnotationHub resources
This package provides a client for the Bioconductor AnnotationHub web resource. The AnnotationHub web resource provides a central location where genomic files (e.g., VCF, bed, wig) and other resources from standard locations (e.g., UCSC, Ensembl) can be discovered. The resource includes metadata about each resource, e.g., a textual description, tags, and date of modification. The client creates and manages a local cache of files retrieved by the user, helping with quick and reproducible access.
Last updated 24 days ago
infrastructuredataimportguithirdpartyclientcore-package
12.90 score 16 stars 102 packages 2.4k scripts 17k downloadsShortRead - FASTQ input and manipulation
This package implements sampling, iteration, and input of FASTQ files. The package includes functions for filtering and trimming reads, and for generating a quality assessment report. Data are represented as DNAStringSet-derived objects, and easily manipulated for a diversity of purposes. The package also contains legacy support for early single-end, ungapped alignment formats.
Last updated 24 days ago
dataimportsequencingqualitycontrolbioconductor-packagecore-package
12.28 score 8 stars 51 packages 1.7k scripts 12k downloadsHDF5Array - HDF5 datasets as array-like objects in R
The HDF5Array package is an HDF5 backend for DelayedArray objects. It implements the HDF5Array, H5SparseMatrix, H5ADMatrix, and TENxMatrix classes, 4 convenient and memory-efficient array-like containers for representing and manipulating either: (1) a conventional (a.k.a. dense) HDF5 dataset, (2) an HDF5 sparse matrix (stored in CSR/CSC/Yale format), (3) the central matrix of an h5ad file (or any matrix in the /layers group), or (4) a 10x Genomics sparse matrix. All these containers are DelayedArray extensions and thus support all operations (delayed or block-processed) supported by DelayedArray objects.
Last updated 23 days ago
infrastructuredatarepresentationdataimportsequencingrnaseqcoverageannotationgenomeannotationsinglecellimmunooncologybioconductor-packagecore-package
12.08 score 11 stars 129 packages 828 scripts 27k downloadsGenomicDataCommons - NIH / NCI Genomic Data Commons Access
Programmatically access the NIH / NCI Genomic Data Commons RESTful service.
Last updated 24 days ago
dataimportsequencingapi-clientbioconductorbioinformaticscancercore-servicesdata-sciencegenomicsncitcgavignette
11.67 score 84 stars 10 packages 181 scripts 1.6k downloadsMatrixGenerics - S4 Generic Summary Statistic Functions that Operate on Matrix-Like Objects
S4 generic functions modeled after the 'matrixStats' API for alternative matrix implementations. Packages with alternative matrix implementation can depend on this package and implement the generic functions that are defined here for a useful set of row and column summary statistics. Other package developers can import this package and handle a different matrix implementations without worrying about incompatibilities.
Last updated 24 days ago
infrastructuresoftwarebioconductor-packagecore-package
11.48 score 12 stars 1.3k packages 117 scripts 71k downloadsSparseArray - High-performance sparse data representation and manipulation in R
The SparseArray package provides array-like containers for efficient in-memory representation of multidimensional sparse data in R (arrays and matrices). The package defines the SparseArray virtual class and two concrete subclasses: COO_SparseArray and SVT_SparseArray. Each subclass uses its own internal representation of the nonzero multidimensional data: the "COO layout" and the "SVT layout", respectively. SVT_SparseArray objects mimic as much as possible the behavior of ordinary matrix and array objects in base R. In particular, they suppport most of the "standard matrix and array API" defined in base R and in the matrixStats package from CRAN.
Last updated 8 days ago
infrastructuredatarepresentationbioconductor-packagecore-package
11.44 score 8 stars 1.2k packages 45 scripts 75k downloadsBiocStyle - Standard styles for vignettes and other Bioconductor documents
Provides standard formatting styles for Bioconductor PDF and HTML documents. Package vignettes illustrate use and functionality.
Last updated 24 days ago
softwarebioconductor-packagecore-package
11.35 score 12 stars 46 packages 1.2k scripts 11k downloadsS4Arrays - Foundation of array-like containers in Bioconductor
The S4Arrays package defines the Array virtual class to be extended by other S4 classes that wish to implement a container with an array-like semantic. It also provides: (1) low-level functionality meant to help the developer of such container to implement basic operations like display, subsetting, or coercion of their array-like objects to an ordinary matrix or array, and (2) a framework that facilitates block processing of array-like objects (typically on-disk objects).
Last updated 23 days ago
infrastructuredatarepresentationbioconductor-packagecore-package
11.35 score 5 stars 1.2k packages 7 scripts 73k downloadsRhtslib - HTSlib high-throughput sequencing library as an R package
This package provides version 1.18 of the 'HTSlib' C library for high-throughput sequence analysis. The package is primarily useful to developers of other R packages who wish to make use of HTSlib. Motivation and instructions for use of this package are in the vignette, vignette(package="Rhtslib", "Rhtslib").
Last updated 24 days ago
dataimportsequencingbioconductor-packagecore-package
11.34 score 11 stars 590 packages 3 scripts 47k downloadsExperimentHub - Client to access ExperimentHub resources
This package provides a client for the Bioconductor ExperimentHub web resource. ExperimentHub provides a central location where curated data from experiments, publications or training courses can be accessed. Each resource has associated metadata, tags and date of modification. The client creates and manages a local cache of files retrieved enabling quick and reproducible access.
Last updated 24 days ago
infrastructuredataimportguithirdpartyclientcore-package
11.11 score 9 stars 58 packages 708 scripts 11k downloadsXVector - Foundation of external vector representation and manipulation in Bioconductor
Provides memory efficient S4 classes for storing sequences "externally" (e.g. behind an R external pointer, or on disk).
Last updated 24 days ago
infrastructuredatarepresentationbioconductor-packagecore-package
11.06 score 2 stars 1.7k packages 67 scripts 94k downloadsBiocIO - Standard Input and Output for Bioconductor Packages
The `BiocIO` package contains high-level abstract classes and generics used by developers to build IO funcionality within the Bioconductor suite of packages. Implements `import()` and `export()` standard generics for importing and exporting biological data formats. `import()` supports whole-file as well as chunk-wise iterative import. The `import()` interface optionally provides a standard mechanism for 'lazy' access via `filter()` (on row or element-like components of the file resource), `select()` (on column-like components of the file resource) and `collect()`. The `import()` interface optionally provides transparent access to remote (e.g. via https) as well as local access. Developers can register a file extension, e.g., `.loom` for dispatch from character-based URIs to specific `import()` / `export()` methods based on classes representing file types, e.g., `LoomFile()`.
Last updated 14 hours ago
annotationdataimportbioconductor-packagecore-package
10.20 score 1 stars 493 packages 19 scripts 32k downloadsAnnotationFilter - Facilities for Filtering Bioconductor Annotation Resources
This package provides class and other infrastructure to implement filters for manipulating Bioconductor annotation resources. The filters will be used by ensembldb, Organism.dplyr, and other packages.
Last updated 24 days ago
annotationinfrastructuresoftwarebioconductor-packagecore-package
10.18 score 5 stars 160 packages 44 scripts 18k downloadsBiocCheck - Bioconductor-specific package checks
BiocCheck guides maintainers through Bioconductor best practicies. It runs Bioconductor-specific package checks by searching through package code, examples, and vignettes. Maintainers are required to address all errors, warnings, and most notes produced.
Last updated 14 days ago
infrastructurebioconductor-packagecore-services
10.15 score 8 stars 6 packages 115 scripts 3.7k downloadsUCSC.utils - Low-level utilities to retrieve data from the UCSC Genome Browser
A set of low-level utilities to retrieve data from the UCSC Genome Browser. Most functions in the package access the data via the UCSC REST API but some of them query the UCSC MySQL server directly. Note that the primary purpose of the package is to support higher-level functionalities implemented in downstream packages like GenomeInfoDb or txdbmaker.
Last updated 24 days ago
infrastructuregenomeassemblyannotationgenomeannotationdataimportbioconductor-packagecore-package
10.03 score 1 stars 1.7k packages 4 scripts 53k downloadstxdbmaker - Tools for making TxDb objects from genomic annotations
A set of tools for making TxDb objects from genomic annotations from various sources (e.g. UCSC, Ensembl, and GFF files). These tools allow the user to download the genomic locations of transcripts, exons, and CDS, for a given assembly, and to import them in a TxDb object. TxDb objects are implemented in the GenomicFeatures package, together with flexible methods for extracting the desired features in convenient formats.
Last updated 10 hours ago
infrastructuredataimportannotationgenomeannotationgenomeassemblygeneticssequencingbioconductor-packagecore-package
9.49 score 2 stars 87 packages 82 scripts 4.8k downloadsbiocViews - Categorized views of R package repositories
Infrastructure to support 'views' used to classify Bioconductor packages. 'biocViews' are directed acyclic graphs of terms from a controlled vocabulary. There are three major classifications, corresponding to 'software', 'annotation', and 'experiment data' packages.
Last updated 24 days ago
infrastructurebioconductor-packagecore-package
9.11 score 4 stars 14 packages 30 scripts 7.0k downloadsRaggedExperiment - Representation of Sparse Experiments and Assays Across Samples
This package provides a flexible representation of copy number, mutation, and other data that fit into the ragged array schema for genomic location data. The basic representation of such data provides a rectangular flat table interface to the user with range information in the rows and samples/specimen in the columns. The RaggedExperiment class derives from a GRangesList representation and provides a semblance of a rectangular dataset.
Last updated 24 days ago
infrastructuredatarepresentationcopynumbercore-packagedata-structuremutations
8.88 score 4 stars 13 packages 74 scripts 1.4k downloadsBiocBaseUtils - General utility functions for developing Bioconductor packages
The package provides utility functions related to package development. These include functions that replace slots, and selectors for show methods. It aims to coalesce the various helper functions often re-used throughout the Bioconductor ecosystem.
Last updated 24 days ago
softwareinfrastructurebioconductor-packagecore-package
8.77 score 4 stars 155 packages 3 scripts 11k downloadsAnnotationForge - Tools for building SQLite-based annotation data packages
Provides code for generating Annotation packages and their databases. Packages produced are intended to be used with AnnotationDbi.
Last updated 24 days ago
annotationinfrastructurebioconductor-packagecore-package
8.41 score 4 stars 20 packages 125 scripts 3.3k downloadspwalign - Perform pairwise sequence alignments
The two main functions in the package are pairwiseAlignment() and stringDist(). The former solves (Needleman-Wunsch) global alignment, (Smith-Waterman) local alignment, and (ends-free) overlap alignment problems. The latter computes the Levenshtein edit distance or pairwise alignment score matrix for a set of strings.
Last updated 24 days ago
alignmentsequencematchingsequencinggeneticsbioconductor-package
8.10 score 1 stars 106 packages 21 scripts 7.5k downloadsUniProt.ws - R Interface to UniProt Web Services
The Universal Protein Resource (UniProt) is a comprehensive resource for protein sequence and annotation data. This package provides a collection of functions for retrieving, processing, and re-packaging UniProt web services. The package makes use of UniProt's modernized REST API and allows mapping of identifiers accross different databases.
Last updated 16 days ago
annotationinfrastructuregokeggbiocartabioconductor-packagecore-package
7.58 score 4 stars 4 packages 159 scripts 681 downloadsOrganism.dplyr - dplyr-based Access to Bioconductor Annotation Resources
This package provides an alternative interface to Bioconductor 'annotation' resources, in particular the gene identifier mapping functionality of the 'org' packages (e.g., org.Hs.eg.db) and the genome coordinate functionality of the 'TxDb' packages (e.g., TxDb.Hsapiens.UCSC.hg38.knownGene).
Last updated 24 days ago
annotationsequencinggenomeannotationbioconductor-packagecore-package
6.75 score 3 stars 1 packages 60 scripts 739 downloadsAnVILBase - Generic functions for interacting with the AnVIL ecosystem
Provides generic functions for interacting with the AnVIL ecosystem. Packages that use either GCP or Azure in AnVIL are built on top of AnVILBase. Extension packages will provide methods for interacting with other cloud providers.
Last updated 24 days ago
softwareinfrastructure
6.70 score 13 packages 75 scripts 150 downloadsGDSArray - Representing GDS files as array-like objects
GDS files are widely used to represent genotyping or sequence data. The GDSArray package implements the `GDSArray` class to represent nodes in GDS files in a matrix-like representation that allows easy manipulation (e.g., subsetting, mathematical transformation) in _R_. The data remains on disk until needed, so that very large files can be processed.
Last updated 24 days ago
infrastructuredatarepresentationsequencinggenotypingarray
6.65 score 5 stars 2 packages 8 scripts 498 downloadsBSgenomeForge - Forge your own BSgenome data package
A set of tools to forge BSgenome data packages. Supersedes the old seed-based tools from the BSgenome software package. This package allows the user to create a BSgenome data package in one function call, simplifying the old seed-based process.
Last updated 24 days ago
infrastructuredatarepresentationgenomeassemblyannotationgenomeannotationsequencingalignmentdataimportsequencematchingbioconductor-packagecore-package
6.30 score 4 stars 4 scripts 244 downloadsiNETgrate - Integrates DNA methylation data with gene expression in a single gene network
The iNETgrate package provides functions to build a correlation network in which nodes are genes. DNA methylation and gene expression data are integrated to define the connections between genes. This network is used to identify modules (clusters) of genes. The biological information in each of the resulting modules is represented by an eigengene. These biological signatures can be used as features e.g., for classification of patients into risk categories. The resulting biological signatures are very robust and give a holistic view of the underlying molecular changes.
Last updated 24 days ago
geneexpressionrnaseqdnamethylationnetworkinferencenetworkgraphandnetworkbiomedicalinformaticssystemsbiologytranscriptomicsclassificationclusteringdimensionreductionprincipalcomponentmrnamicroarraynormalizationgenepredictionkeggsurvivalcore-services
6.16 score 73 stars 1 scripts 121 downloadsAnVILGCP - The GCP R Client for the AnVIL
The package provides a set of functions to interact with the Google Cloud Platform (GCP) services on the AnVIL platform. The package is designed to work with the AnVIL package. User-level interaction with this package should be minimal.
Last updated 23 days ago
softwareinfrastructurethirdpartyclientdataimport
5.86 score 3 packages 37 scripts 94 downloadsAnVILAz - R / Bioconductor Support for the AnVIL Azure Platform
The AnVIL is a cloud computing resource developed in part by the National Human Genome Research Institute. The AnVILAz package supports end-users and developers using the AnVIL platform in the Azure cloud. The package provides a programmatic interface to AnVIL resources, including workspaces, notebooks, tables, and workflows. The package also provides utilities for managing resources, including copying files to and from Azure Blob Storage, and creating shared access signatures (SAS) for secure access to Azure resources.
Last updated 24 days ago
softwareinfrastructurethirdpartyclient
5.64 score 5 scripts 99 downloadsSplicingGraphs - Create, manipulate, visualize splicing graphs, and assign RNA-seq reads to them
This package allows the user to create, manipulate, and visualize splicing graphs and their bubbles based on a gene model for a given organism. Additionally it allows the user to assign RNA-seq reads to the edges of a set of splicing graphs, and to summarize them in different ways.
Last updated 24 days ago
geneticsannotationdatarepresentationvisualizationsequencingrnaseqgeneexpressionalternativesplicingtranscriptionimmunooncologybioconductor-package
5.26 score 2 stars 8 scripts 278 downloadsVariantExperiment - A RangedSummarizedExperiment Container for VCF/GDS Data with GDS Backend
VariantExperiment is a Bioconductor package for saving data in VCF/GDS format into RangedSummarizedExperiment object. The high-throughput genetic/genomic data are saved in GDSArray objects. The annotation data for features/samples are saved in DelayedDataFrame format with mono-dimensional GDSArray in each column. The on-disk representation of both assay data and annotation data achieves on-disk reading and processing and saves memory space significantly. The interface of RangedSummarizedExperiment data format enables easy and common manipulations for high-throughput genetic/genomic data with common SummarizedExperiment metaphor in R and Bioconductor.
Last updated 24 days ago
infrastructuredatarepresentationsequencingannotationgenomeannotationgenotypingarray
5.00 score 1 stars 2 scripts 149 downloadsHubPub - Utilities to create and use Bioconductor Hubs
HubPub provides users with functionality to help with the Bioconductor Hub structures. The package provides the ability to create a skeleton of a Hub style package that the user can then populate with the necessary information. There are also functions to help add resources to the Hub package metadata files as well as publish data to the Bioconductor S3 bucket.
Last updated 24 days ago
dataimportinfrastructuresoftwarethirdpartyclientbioconductor-package
4.95 score 3 stars 4 scripts 236 downloadsDelayedDataFrame - Delayed operation on DataFrame using standard DataFrame metaphor
Based on the standard DataFrame metaphor, we are trying to implement the feature of delayed operation on the DelayedDataFrame, with a slot of lazyIndex, which saves the mapping indexes for each column of DelayedDataFrame. Methods like show, validity check, [/[[ subsetting, rbind/cbind are implemented for DelayedDataFrame to be operated around lazyIndex. The listData slot stays untouched until a realization call e.g., DataFrame constructor OR as.list() is invoked.
Last updated 24 days ago
infrastructuredatarepresentation
4.95 score 1 stars 1 packages 3 scripts 174 downloadsSQLDataFrame - Representation of SQL tables in DataFrame metaphor
Implements bindings for SQL tables that are compatible with Bioconductor S4 data structures, namely the DataFrame and DelayedArray. This allows SQL-derived data to be easily used inside other Bioconductor objects (e.g., SummarizedExperiments) while keeping everything on disk.
Last updated 24 days ago
datarepresentationinfrastructuresoftware
4.51 score 2 stars 5 scripts 130 downloadsupdateObject - Find/fix old serialized S4 instances
A set of tools built around updateObject() to work with old serialized S4 instances. The package is primarily useful to package maintainers who want to update the serialized S4 instances included in their package. This is still work-in-progress.
Last updated 24 days ago
infrastructuredatarepresentationbioconductor-packagecore-package
4.48 score 1 stars 3 scripts 98 downloadsBiocHubsShiny - View AnnotationHub and ExperimentHub Resources Interactively
A package that allows interactive exploration of AnnotationHub and ExperimentHub resources. It uses DT / DataTable to display resources for multiple organisms. It provides template code for reproducibility and for downloading resources via the indicated Hub package.
Last updated 14 days ago
softwareshinyapps
3.70 score 1 scripts 148 downloads