Packages — R (Page 8 of 32)

Packages menu:

Browse alphabetically

0-9 A B C D E F G H I J K L M N O P Q R S T U V W X Y Z

r-inspect 1.18.0

INSPEcT (INference of Synthesis, Processing and dEgradation rates in Time-Course experiments) analyses 4sU-seq and RNA-seq time-course data in order to evaluate synthesis, processing and degradation rates and assess via modeling the rates that…

r-interactionset 1.16.0

This package provides the `GInteractions', `InteractionSet' and `ContactMatrix' objects and associated methods for storing and manipulating genomic interaction data from Hi-C and ChIA-PET experiments. …

r-interactivedisplaybase 1.26.3

This package contains the basic methods needed to generate interactive Shiny-based display methods for Bioconductor objects. …

r-inum 1.0-1

This package provides an enum-type representation of vectors and representation of intervals, including a method of coercing variables in data frames. …

r-ioniser 2.12.0

IONiseR provides tools for the quality assessment of Oxford Nanopore MinION data. It extracts summary statistics from a set of fast5 files and can be used either before or after base…

r-ipred 0.9-9

This package provides improved predictive models by indirect classification and bagging for classification, regression and survival problems as well as resampling based estimators of prediction error. …

r-iranges 2.22.2

This package provides efficient low-level and highly reusable S4 classes for storing ranges of integers, RLE vectors (Run-Length Encoding), and, more generally, data that can be organized sequentially (formally defined as `Vector' objects),…

r-irdisplay 0.7.0

This package provides an interface to the rich display capabilities of Jupyter front-ends (e.g. Jupyter Notebook). It is designed to be used from a running IRkernel session. …

r-irkernel 1.1.1

The R kernel for the Jupyter environment executes R code which the front-end (Jupyter Notebook or other front-ends) submits to the kernel via the network. …

r-irlba 2.3.3

This package provides fast and memory efficient methods for truncated singular and eigenvalue decompositions, as well as for principal component analysis of large sparse or dense matrices. …

r-irtoys 0.2.1

This package provides a collection of functions useful in learning and practicing "Item Response Theory" (IRT), which can be combined into larger programs. It provides basic CTT analysis, a simple common…

r-iso 0.0-18.1

This package provides support for linear order and unimodal order (univariate) isotonic regression and bivariate isotonic regression with linear order on both variables. …

r-isoband 0.2.2

This package provides a fast C++ implementation to generate contour lines (isolines) and contour polygons (isobands) from regularly spaced grids containing elevation data. …

r-isocodes 2020.03.16

This package provides ISO language, territory, currency, script and character codes. It provides ISO 639 language codes, ISO 3166 territory codes, ISO 4217 currency codes, ISO 15924 script codes, and the…

r-iterators 1.0.12

This package provides support for iterators, which allow a programmer to traverse through all the elements of a vector, list, or other collection of data. …

r-itertools 0.1-3

This package provides various tools for creating iterators, many patterned after functions in the Python `itertools' module, and others patterned after functions in the snow package. …

r-jomo 2.7-1

Similarly to Schafer's package pan, jomo is a package for multilevel joint modelling multiple imputation http://doi.org/10.1002/9781119942283 (Carpenter and Kenward (2013)). Novel aspects of jomo are the possibility of handling binary and categorical…

r-jpeg 0.1-8.1

This package provides a way to read, write and display bitmap images stored in the JPEG format with R. It can read and write both files and in-memory raw vectors. …

r-jsonlite 1.7.0

The jsonlite package provides a fast JSON parser and generator optimized for statistical data and the web. It offers flexible, robust, high performance tools for working with JSON in R and…

r-kableextra 1.1.0

Build complex HTML or LaTeX tables using `kable()' from `knitr' and the piping syntax from `magrittr'. The function `kable()' is a light weight table generator coming from `knitr'. This package…

r-karyoploter 1.14.0

This package creates karyotype plots of arbitrary genomes and offers a complete set of functions to plot arbitrary data on them. It mimicks many R base graphics functions coupling them with…

r-keggrest 1.28.0

This package provides a package that provides a client interface to the "Kyoto Encyclopedia of Genes and Genomes" (KEGG) REST server. …

r-kendall 2.2

This package computes the Kendall rank correlation and Mann-Kendall trend test. …

r-kernelfactory 0.3.0

Kernel factory is an ensemble method where each base classifier (random forest) is fit on the kernel matrix of a subset of the training data. …

r-kernlab 0.9-29

This package provides kernel-based machine learning methods for classification, regression, clustering, novelty detection, quantile regression and dimensionality reduction. Among other methods `kernlab' includes Support Vector Machines, Spectral Clustering, Kernel PCA, Gaussian Processes…

r-kernsmooth 2.23-17

This package provides functions for kernel smoothing (and density estimation) corresponding to the book: Wand, M.P. and Jones, M.C. (1995) "Kernel Smoothing". …

r-kmer 1.1.2

`r-kmer' is an R package for rapidly computing distance matrices and clustering large sequence datasets using fast alignment-free k-mer counting and recursive k-means partitioning. …

r-knitr 1.29

This package provides a general-purpose tool for dynamic report generation in R using Literate Programming techniques. …

r-knitrbootstrap 1.0.2

This package provides a framework to create Bootstrap 3 HTML reports from knitr Rmarkdown. …

r-knn-covertree 1.0

Similarly to the FNN package, this package allows calculation of the k nearest neighbors (kNN) of a data matrix. The implementation is based on cover trees introduced by Alina Beygelzimer, Sham…

r-kohonen 3.0.10

This package provides functions to train "self-organising maps" (SOMs). Also interrogation of the maps and prediction using trained maps are supported. The name of the package refers to Teuvo Kohonen,…

r-ks 1.11.7

This package provides kernel smoothers for univariate and multivariate data, including density functions, density derivatives, cumulative distributions, modal clustering, discriminant analysis, and two-sample hypothesis testing. …

r-ksamples 1.2-9

This package provides tools to compares k samples using the Anderson-Darling test, Kruskal-Wallis type tests with different rank score criteria, Steel's multiple comparison test, and the Jonckheere-Terpstra (JT) test. It computes asymptotic,…

r-kutils 1.70

This package provides tools for data importation, recoding, and inspection. There are functions to create new project folders, R code templates, create uniquely named output directories, and to quickly obtain a visual…

r-labeling 0.3

The labeling package provides a range of axis labeling algorithms. …

r-laeken 0.5.1

This package provides tools for the estimation of indicators on social exclusion and poverty, as well as an implementation of Pareto tail modeling for empirical income distributions. …

r-lambda-r 1.2.4

This package provides a language extension to efficiently write functional programs in R. Syntax extensions include multi-part function definitions, pattern matching, guard statements, built-in (optional) type safety. …

r-lars 1.2

Least Angle Regression ("LAR") is a model selection algorithm; a useful and less greedy version of traditional forward selection methods. A simple modification of the LAR algorithm implements Tibshirani's Lasso; the…

r-lassopv 0.2.0

This package enables you to estimate the p-values for predictors x against target variable y in Lasso regression, using the regularization strength when each predictor enters the active set of regularization path…

r-later 1.1.0.1

This package provides tools to execute arbitrary R or C functions some time after the current time, after the R execution stack has emptied. …

r-latex2exp 0.4.0

`latex2exp' parses and converts LaTeX math formulas to R's plotmath expressions, used to enter mathematical formulas and symbols to be rendered as text, axis labels, etc. throughout R's plotting system. …

r-lattice 0.20-41

The lattice package provides a powerful and elegant high-level data visualization system inspired by Trellis graphics, with an emphasis on multivariate data. Lattice is sufficient for typical graphics needs, and is also…

r-latticeextra 0.6-29

Building on the infrastructure provided by the lattice package, this package provides several new high-level graphics functions and methods, as well as additional utilities such as panel and axis annotation functions. …

r-lava 1.6.7

This package provides tools for the estimation and simulation of latent variable models. …

r-lavaan 0.6-7

This package provides tools to fit a variety of latent variable models, including confirmatory factor analysis, structural equation modeling and latent growth curve models. …

r-lazyeval 0.2.2

This package provides the tools necessary to do non-standard evaluation (NSE) in R. …

r-lda 1.4.2

This package implements "latent Dirichlet allocation" (LDA) and related models. This includes (but is not limited to) sLDA, corrLDA, and the mixed-membership stochastic blockmodel. Inference for all of these models is…

r-ldblock 1.18.0

This package defines data structures for "linkage disequilibrium" (LD) measures in populations. Its purpose is to simplify handling of existing population-level data for the purpose of flexibly defining LD blocks. …

r-ldheatmap 0.99-8

This package provides tools to produce a graphical display, as a heat map, of measures of pairwise linkage disequilibria between SNPs. Users may optionally include the physical locations or genetic map…

r-leaps 3.1

This package provides tools for regression subset selection, including exhaustive search. …

r-learnbayes 2.15.1

This package provides a collection of functions helpful in learning the basic tenets of Bayesian statistical inference. It contains functions for summarizing basic one and two parameter posterior distributions and predictive distributions.…

r-learnr 0.10.1

This package provides tools to create interactive tutorials using R Markdown. Use a combination of narrative, figures, videos, exercises, and quizzes to create self-paced tutorials for learning about R and R packages. …

r-leiden 0.3.3

This package implements the Python `leidenalg' module to be called in R. It enables clustering using the Leiden algorithm for partitioning a graph into communities. See also Traag et al…

r-lemon 0.4.5

This package provides functions for working with legends and axis lines of ggplot2, facets that repeat axis lines on all panels, and some knitr extensions. …

r-lhs 1.0.2

This package provides a number of methods for creating and augmenting Latin Hypercube Samples. …

r-libcoin 1.0-5

This package provides basic infrastructure for linear test statistics and permutation inference in the framework of Strasser and Weber (1999). …

r-lifecycle 0.2.0

Manage the life cycle of your exported functions with shared conventions, documentation badges, and non-invasive deprecation warnings. The lifecycle package defines four development stages (experimental, maturing, stable, and questioning) and three deprecation…

r-liger 0.4.2

LIGER is a package for integrating and analyzing multiple single-cell datasets, developed and maintained by the Macosko lab. It relies on integrative non-negative matrix factorization to identify shared and dataset-specific factors. …

r-lim 1.4.6

This package provides functions that read and solve linear inverse problems (food web problems, linear programming problems). …

r-limma 3.44.3

This package can be used for the analysis of gene expression studies, especially the use of linear models for analysing designed experiments and the assessment of differential expression. The analysis methods…

r-limsolve 1.5.6

This package provides functions that: 1. find the minimum/maximum of a linear or quadratic function, 2. sample an underdetermined or overdetermined system, 3. solve a linear system…

r-linnorm 2.12.0

Linnorm is an R package for the analysis of RNA-seq, scRNA-seq, ChIP-seq count data or any large scale count data. It transforms such datasets for parametric tests. In addition to…

r-linprog 0.9-2

This package can be used to solve Linear Programming / Linear Optimization problems by using the simplex algorithm. …

r-lintr 2.0.1

This package checks adherence to a given style, syntax errors and possible semantic issues. It supports on the fly checking of R code edited with `RStudio IDE', `Emacs' and `Vim'. …

r-lisreltor 0.1.4

This is an unofficial package aimed at automating the import of LISREL output in R. …

r-listenv 0.8.0

This package implements list environments. List environments are environments that have list-like properties. For instance, the elements of a list environment are ordered and can be accessed and iterated over…

r-lme4 1.1-23

This package provides fit linear and generalized linear mixed-effects models. The models and their components are represented using S4 classes and methods. The core computational algorithms are implemented using the Eigen C++…

r-lmertest 3.1-2

This package provides p-values in type I, II or III anova and summary tables for `lmer' model fits via Satterthwaite's degrees of freedom method. A Kenward-Roger method is also available via…

r-lmoments 1.3-1

This package contains functions to estimate L-moments and trimmed L-moments from the data. It also contains functions to estimate the parameters of the normal polynomial quantile mixture and the Cauchy polynomial…

r-lmtest 0.9-37

This package provides a collection of tests, data sets, and examples for diagnostic checking in linear regression models. Furthermore, some generic tools for inference in parametric models are provided. …

r-locfit 1.5-9.4

This package provides functions used for local regression, likelihood and density estimation. …

r-longitudinal 1.1.12

This package contains general data structures and functions for longitudinal data with multiple variables, repeated measurements, and irregularly spaced time points. It also implements a shrinkage estimator of dynamical correlation and dynamical…

r-loo 2.3.1

This package provides an implementation of efficient approximate "leave-one-out" (LOO) cross-validation for Bayesian models fit using Markov chain Monte Carlo, as described in `doi:10.1007/s11222-016-9696-4'. The approximation uses "Pareto smoothed importance sampling" (PSIS),…

r-lpsolve 5.6.15

Lp_solve is software for solving linear, integer and mixed integer programs. This implementation supplies a "wrapper" function in C and some R functions that solve general linear/integer problems, assignment problems, and transportation problems. …

r-lpsymphony 1.16.0

This package was derived from Rsymphony. The package provides an R interface to SYMPHONY, a linear programming solver written in C++. The main difference between this package and Rsymphony is…

r-lsd 4.1-0

This package creates lots of colorful plots in a multitude of variations. Try a demo of the LSD by running `demotour()'. …

r-lsei 1.2-0.1

It contains functions that solve least squares linear regression problems under linear equality/inequality constraints. Functions for solving quadratic programming problems are also available, which transform such problems into least squares ones first. …

r-ltm 1.1-1

This is a package supporting the analysis of multivariate dichotomous and polytomous data using latent trait models under the Item Response Theory approach. It includes the Rasch, the Two-Parameter Logistic, the…

r-lubridate 1.7.9

This package provides functions to work with date-times and time-spans: fast and user friendly parsing of date-time data, extraction and updating of components of a date-time (years, months, days, hours, minutes, and…

r-lumi 2.40.0

The lumi package provides an integrated solution for the Illumina microarray data analysis. It includes functions of Illumina BeadStudio (GenomeStudio) data input, quality control, BeadArray-specific variance stabilization, normalization and gene annotation at…

r-m3c 1.10.0

M3C is a consensus clustering algorithm that uses a Monte Carlo simulation to eliminate overestimation of `K' and can reject the null hypothesis `K=1'. …

r-magic 1.5-9

This package provides a collection of efficient, vectorized algorithms for the creation and investigation of magic squares and hypercubes, including a variety of functions for the manipulation and analysis of arbitrarily dimensioned arrays. …

r-magick 2.4.0

This package provides bindings to ImageMagick, a comprehensive image processing library. It supports many common formats (PNG, JPEG, TIFF, PDF, etc.) and manipulations (rotate, scale, crop, trim, flip, blur, etc). …

r-magrittr 1.5

Magrittr provides a mechanism for chaining commands with a new forward-pipe operator, %>%. This operator will forward a value, or the result of an expression, into the next function call/expression. …

r-maldiquant 1.19.3

This package provides a complete analysis pipeline for matrix-assisted laser desorption/ionization-time-of-flight (MALDI-TOF) and other two-dimensional mass spectrometry data. In addition to commonly used plotting and processing methods it includes distinctive features, namely…

r-manipulatewidget 0.10.1

This package lets you create in just a few lines of R code a nice user interface to modify the data or the graphical parameters of one or multiple interactive charts. …

r-mapplots 1.5.1

This package helps you create simple maps; add sub-plots like pie plots to a map or any other plot; format, plot and export gridded data. The package was developed for displaying…

r-mapproj 1.2.7

This package converts latitude/longitude into projected coordinates. …

r-maps 3.3.0

This package provides an R module for display of maps. Projection code and larger maps are in separate packages (`mapproj' and `mapdata'). …

r-maptools 1.0-1

This package provides a set of tools for manipulating and reading geographic data, in particular ESRI Shapefiles. It includes binary access to GSHHG shoreline files. The package also provides interface…

r-markdown 1.1

This package provides R bindings to the Sundown Markdown rendering library (https://github.com/vmg/sundown). Markdown is a plain-text formatting syntax that can be converted to XHTML or other formats. …

r-marray 1.66.0

This package contains class definitions for two-color spotted microarray data. It also includes functions for data input, diagnostic plots, normalization and quality checking. …

r-mass 7.3-51.6

This package provides functions and datasets for the book "Modern Applied Statistics with S" (4th edition, 2002) by Venables and Ripley. …

r-massspecwavelet 1.54.0

The MassSpecWavelet package aims to process "Mass Spectrometry" (MS) data mainly through the use of wavelet transforms. It supports peak detection based on "Continuous Wavelet Transform" (CWT). …

r-mast 1.14.0

This package provides methods and models for handling zero-inflated single cell assay data. …

r-matrix 1.2-18

This package provides classes and methods for dense and sparse matrices and operations on them using LAPACK and SuiteSparse. …

r-matrix-utils 0.9.8

This package implements data manipulation methods such as `cast', `aggregate', and `merge'/`join' for Matrix and Matrix-like objects. …

r-matrixcalc 1.0-3

This package provides a collection of functions to support matrix calculations for probability, econometric and numerical analysis. There are additional functions that are comparable to APL functions which are useful for…

r-matrixmodels 0.4-1

This package models with sparse and dense matrix matrices, using modular prediction and response module classes. …

r-matrixstats 0.56.0

This package provides methods operating on rows and columns of matrices, e.g. `rowMedians()', `rowRanks()', and `rowSds()'. There are also some vector-based methods, e.g. `binMeans()', `madDiff()' and `weightedMedians()'. All methods have…

Packages menu:

Browse alphabetically

0-9 A B C D E F G H I J K L M N O P Q R S T U V W X Y Z