r-sensemakr
|
public |
Implements a suite of sensitivity analysis tools that extends the traditional omitted variable bias framework and makes it easier to understand the impact of omitted variables in regression models, as discussed in Cinelli and Hazlett (2018) <https://www.researchgate.net/publication/322509816_Making_Sense_of_Sensitivity_Extending_Omitted_Variable_Bias>.
|
2023-06-16 |
r-semnetdictionaries
|
public |
Implements dictionaries that can be used in the 'SemNetCleaner' package. Also includes several functions aimed at facilitating the text cleaning analysis in the 'SemNetCleaner' package. This package is designed to integrate and update word lists and dictionaries based on each user's individual needs by allowing users to store and save their own dictionaries. Dictionaries can be added to the 'SemNetDictionaries' package by submitting user-defined dictionaries to <https://github.com/AlexChristensen/SemNetDictionaries>.
|
2023-06-16 |
r-semipar
|
public |
Functions for semiparametric regression analysis, to complement the book: Ruppert, D., Wand, M.P. and Carroll, R.J. (2003). Semiparametric Regression. Cambridge University Press.
|
2023-06-16 |
r-semid
|
public |
Provides routines to check identifiability or non-identifiability of linear structural equation models as described in Drton, Foygel, and Sullivant (2011) <DOI:10.1214/10-AOS859>, Foygel, Draisma, and Drton (2012) <DOI:10.1214/12-AOS1012>, and other works. The routines are based on the graphical representation of structural equation models by a path diagram/mixed graph.
|
2023-06-16 |
r-seedcalc
|
public |
Functions to calculate seed germination and seedling emergence and growth indexes. The main indexes for germination and seedling emergence, considering the time for seed germinate are: T10, T50 and T90, in Farooq et al. (2005) <10.1111/j.1744-7909.2005.00031.x>; and MGT, in Labouriau (1983). Considering the germination speed are: Germination Speed Index, in Maguire (1962), Mean Germination Rate, in Labouriau (1983); considering the homogeneity of germination are: Coefficient of Variation of the Germination Time, in Carvalho et al. (2005) <10.1590/S0100-84042005000300018>, and Variance of Germination, in Labouriau (1983); Uncertainty, in Labouriau and Valadares (1976) <ISSN:0001-3765>; and Synchrony, in Primack (1980). The main seedling indexes are Growth, in Sako (2001), Uniformity, in Sako (2001) and Castan et al. (2018) <doi:10.1590/1678-992x-2016-0401>; and Vigour, in Medeiros and Pereira (2018) <doi:10.1590/1983-40632018v4852340>.
|
2023-06-16 |
r-seasonal
|
public |
Easy-to-use interface to X-13-ARIMA-SEATS, the seasonal adjustment software by the US Census Bureau. It offers full access to almost all options and outputs of X-13, including X-11 and SEATS, automatic ARIMA model search, outlier detection and support for user defined holiday variables, such as Chinese New Year or Indian Diwali. A graphical user interface can be used through the 'seasonalview' package. Uses the X-13-binaries from the 'x13binary' package.
|
2023-06-16 |
r-samplesize
|
public |
Computes sample size for Student's t-test and for the Wilcoxon-Mann-Whitney test for categorical data. The t-test function allows paired and unpaired (balanced / unbalanced) designs as well as homogeneous and heterogeneous variances. The Wilcoxon function allows for ties.
|
2023-06-16 |
r-sprt
|
public |
Perform Wald's Sequential Probability Ratio Test on variables with a Normal, Bernoulli, Exponential and Poisson distribution. Plot acceptance and continuation regions, or create your own with the help of closures.
|
2023-06-16 |
r-spearmanci
|
public |
Functions for conducting jackknife Euclidean / empirical likelihood inference for Spearman's rho (de Carvalho and Marques (2012) <10.1080/10920277.2012.10597644>).
|
2023-06-16 |
r-soilphysics
|
public |
Basic and model-based soil physical analyses.
|
2023-06-16 |
r-slippymath
|
public |
Provides functions for performing common tasks when working with slippy map tile service APIs e.g. Google maps, Open Street Map, Mapbox, Stamen, among others. Functionality includes converting from latitude and longitude to tile numbers, determining tile bounding boxes, and compositing tiles to a georeferenced raster image.
|
2023-06-16 |
r-simplicialcubature
|
public |
Provides methods to integrate functions over m-dimensional simplices in n-dimensional Euclidean space. There are exact methods for polynomials and adaptive methods for integrating an arbitrary function. Dirichlet probabilities are calculated in certain cases.
|
2023-06-16 |
r-simcausal
|
public |
A flexible tool for simulating complex longitudinal data using structural equations, with emphasis on problems in causal inference. Specify interventions and simulate from intervened data generating distributions. Define and evaluate treatment-specific means, the average treatment effects and coefficients from working marginal structural models. User interface designed to facilitate the conduct of transparent and reproducible simulation studies, and allows concise expression of complex functional dependencies for a large number of time-varying nodes. See the package vignette for more information, documentation and examples.
|
2023-06-16 |
r-sigoptr
|
public |
Interfaces with the 'SigOpt' API. More info at <https://sigopt.com>.
|
2023-06-16 |
r-sig
|
public |
Print function signatures and find overly complicated code.
|
2023-06-16 |
r-shinytime
|
public |
Provides a time input widget for Shiny. This widget allows intuitive time input in the '[hh]:[mm]:[ss]' or '[hh]:[mm]' (24H) format by using a separate numeric input for each time component. The interface with R uses date-time objects. See the project page for more information and examples.
|
2023-06-16 |
r-shape
|
public |
Functions for plotting graphical shapes such as ellipses, circles, cylinders, arrows, ...
|
2023-06-16 |
r-settings
|
public |
Provides option settings management that goes beyond R's default 'options' function. With this package, users can define their own option settings manager holding option names, default values and (if so desired) ranges or sets of allowed option values that will be automatically checked. Settings can then be retrieved, altered and reset to defaults with ease. For R programmers and package developers it offers cloning and merging functionality which allows for conveniently defining global and local options, possibly in a multilevel options hierarchy. See the package vignette for some examples concerning functions, S4 classes, and reference classes. There are convenience functions to reset par() and options() to their 'factory defaults'.
|
2023-06-16 |
r-setrank
|
public |
Implements an algorithm to conduct advanced gene set enrichment analysis on the results of genomics experiments.
|
2023-06-16 |
r-session
|
public |
Utility functions for interacting with R processes from external programs. This package includes functions to save and restore session information (including loaded packages, and attached data objects), as well as functions to evaluate strings containing R commands and return the printed results or an execution transcript.
|
2023-06-16 |
r-sensitivitycasecontrol
|
public |
This package performs sensitivity analysis for case-control studies in which some cases may meet a more narrow definition of being a case compared to other cases which only meet a broad definition. The sensitivity analyses are described in Small, Cheng, Halloran and Rosenbaum (2013, "Case Definition and Sensitivity Analysis", Journal of the American Statistical Association, 1457-1468). The functions sens.analysis.mh and sens.analysis.aberrant.rank provide sensitivity analyses based on the Mantel-Haenszel test statistic and aberrant rank test statistic as described in Rosenbaum (1991, "Sensitivity Analysis for Matched Case Control Studies", Biometrics); see also Section 1 of Small et al. The function adaptive.case.test provides adaptive inferences as described in Section 5 of Small et al. The function adaptive.noether.brown provides a sensitivity analysis for a matched cohort study based on an adaptive test. The other functions in the package are internal functions.
|
2023-06-16 |
r-sensibo.sky
|
public |
Provides an interface to the 'Sensibo Sky' API which allows to remotely control non-smart air conditioning units. See <https://sensibo.com> for more informations.
|
2023-06-16 |
r-seminr
|
public |
A powerful, easy to write and easy to modify syntax for specifying and estimating Partial Least Squares (PLS) path models allowing for the latest estimation methods for Consistent PLS as per Dijkstra & Henseler (2015, MISQ 39(2): 297-316), adjusted interactions as per Henseler & Chin (2010) <doi:10.1080/10705510903439003> and bootstrapping utilizing parallel processing as per Hair et al. (2017, ISBN:978-1483377445).
|
2023-06-16 |
r-selectmeta
|
public |
Publication bias, the fact that studies identified for inclusion in a meta analysis do not represent all studies on the topic of interest, is commonly recognized as a threat to the validity of the results of a meta analysis. One way to explicitly model publication bias is via selection models or weighted probability distributions. In this package we provide implementations of several parametric and nonparametric weight functions. The novelty in Rufibach (2011) is the proposal of a non-increasing variant of the nonparametric weight function of Dear & Begg (1992). The new approach potentially offers more insight in the selection process than other methods, but is more flexible than parametric approaches. To maximize the log-likelihood function proposed by Dear & Begg (1992) under a monotonicity constraint we use a differential evolution algorithm proposed by Ardia et al (2010a, b) and implemented in Mullen et al (2009). In addition, we offer a method to compute a confidence interval for the overall effect size theta, adjusted for selection bias as well as a function that computes the simulation-based p-value to assess the null hypothesis of no selection as described in Rufibach (2011, Section 6).
|
2023-06-16 |
r-seer2r
|
public |
read and write SEER*STAT data files
|
2023-06-16 |
r-sdaa
|
public |
Functions and Datasets from Lohr, S. (1999), Sampling: Design and Analysis, Duxbury.
|
2023-06-16 |
r-scrselect
|
public |
Contains four functions used in the DIC-tau_g procedure. SCRSELECT() and SCRSELECTRUN() uses Stochastic Search Variable Selection to select important covariates in the three hazard functions of a semi-competing risks model. These functions perform the Gibbs sampler for variable selection and a Metropolis-Hastings-Green sampler for the number of split points and parameters for the three baseline hazard function. The function SCRSELECT() returns the posterior sample of all quantities sampled in the Gibbs sampler after a burn-in period to a desired file location, while the function SCRSELECTRUN() returns posterior values of important quantities to the DIC-Tau_g procedure in a list. The function DICTAUG() returns a list containing the DIC values for the unique models visited by the DIC-Tau_g grid search. The function ReturnModel() uses SCRSELECTRUN() and DICTAUG() to return a summary of the posterior coefficient vectors for the optimal model along with saving this posterior sample to a desired path location.
|
2023-06-16 |
r-saver
|
public |
An implementation of a regularized regression prediction and empirical Bayes method to recover the true gene expression profile in noisy and sparse single-cell RNA-seq data. See Huang M, et al (2018) <doi:10.1038/s41592-018-0033-z> for more details.
|
2023-06-16 |
r-saery
|
public |
A complete set of functions to calculate several EBLUP (Empirical Best Linear Unbiased Predictor) estimators and their mean squared errors. All estimators are based on an area-level linear mixed model introduced by Rao and Yu in 1994 (see documentation). The REML method is used for fitting this model.
|
2023-06-16 |
r-rxkcd
|
public |
Visualize your favorite XKCD comic strip directly from R. XKCD <https://xkcd.com> web comic content is provided under the Creative Commons Attribution-NonCommercial 2.5 License.
|
2023-06-16 |
r-rvcheck
|
public |
Check latest release version of R and R package (both in 'CRAN', 'Bioconductor' or 'Github').
|
2023-06-16 |
r-rtephra
|
public |
Models and displays tephra transport through custom (windy, turbulent, heterogeneous) atmosphere over custom topography. Includes a Lagrangian (particle-tracking) tephra transport model and a function to save snapshots of model as png files.
|
2023-06-16 |
r-rtematres
|
public |
Exploit controlled vocabularies organized on tematres servers.
|
2023-06-16 |
r-rstripe
|
public |
A convenience interface for communicating with the Stripe payment processor to accept payments online. See <https://stripe.com> for more information.
|
2023-06-16 |
r-rstorm
|
public |
While streaming processing provides opportunities to deal with extremely large and ever growing data sets in (near) real time, the development of streaming algorithms for complex models is often cumbersome: the software packages that facilitate streaming processing in production environments do not provide statisticians with the simulation, estimation, and plotting tools they are used to. Developers of streaming algorithms would thus benefit from the flexibility of [R] to create, plot and compute data while developing streaming algorithms. Package RStorm implements a streaming architecture modeled on Storm for easy development and testing of streaming algorithms in [R]. RStorm is not intended as a production package, but rather a development tool for streaming algorithms.
|
2023-06-16 |
r-rstackdeque
|
public |
Provides fast, persistent (side-effect-free) stack, queue and deque (double-ended-queue) data structures. While deques include a superset of functionality provided by queues, in these implementations queues are more efficient in some specialized situations. See the documentation for rstack, rdeque, and rpqueue for details.
|
2023-06-16 |
r-rsaucelabs
|
public |
Retrieve, update, delete job information from <https://saucelabs.com/>. Poll the 'SauceLabs' services current status and access supported platforms. Send and retrieve files from 'SauceLabs' and manage tunnels associated with 'SauceConnect'.
|
2023-06-16 |
r-rsampling
|
public |
Resampling Stats (http://www.resample.com) is an add-in for running randomization tests in Excel worksheets. The workflow is (1) to define a statistic of interest that can be calculated from a data table, (2) to randomize rows ad/or columns of a data table to simulate a null hypothesis and (3) and to score the value of the statistic from many randomizations. The relative frequency distribution of the statistic in the simulations is then used to infer the probability of the observed value be generated by the null process (probability of Type I error). This package intends to translate this logic for R for teaching purposes. Keeping the original workflow is favored over performance.
|
2023-06-16 |
r-rrate
|
public |
Replication Rate (RR) is the probability of replicating a statistically significant association in genome-wide association studies. This R-package provide the estimation method for replication rate which makes use of the summary statistics from the primary study. We can use the estimated RR to determine the sample size of the replication study, and to check the consistency between the results of the primary study and those of the replication study.
|
2023-06-16 |
r-rodbcdbi
|
public |
An implementation of R's DBI interface using ODBC package as a back-end. This allows R to connect to any DBMS that has a ODBC driver.
|
2023-06-16 |
r-rngforgpd
|
public |
Generation of univariate and multivariate data that follow the generalized Poisson distribution. The details of the univariate part are explained in Demirtas (2017), and the multivariate part is an extension of the correlated Poisson data generation routine that was introduced in Yahav and Shmueli (2012).
|
2023-06-16 |
r-rneos
|
public |
Within this package the XML-RPC API to NEOS <https://neos-server.org/neos/> is implemented. This enables the user to pass optimization problems to NEOS and retrieve results within R.
|
2023-06-16 |
r-rmio
|
public |
Provides header files of 'mio', a cross-platform C++11 header-only library for memory mapped file IO <https://github.com/mandreyel/mio>.
|
2023-06-16 |
r-r.matlab
|
public |
Methods readMat() and writeMat() for reading and writing MAT files. For user with MATLAB v6 or newer installed (either locally or on a remote host), the package also provides methods for controlling MATLAB (trademark) via R and sending and retrieving data between R and MATLAB.
|
2023-06-16 |
r-rkt
|
public |
Contains function rkt which computes the Mann-Kendall test (MK) and the Seasonal and the Regional Kendall Tests for trend (SKT and RKT) and Theil-Sen's slope estimator.
|
2023-06-16 |
r-rismed
|
public |
A set of tools to extract bibliographic content from the National Center for Biotechnology Information (NCBI) databases, including PubMed. The name RISmed is a portmanteau of RIS (for Research Information Systems, a common tag format for bibliographic data) and PubMed.
|
2023-06-16 |
r-rintrojs
|
public |
A wrapper for the 'Intro.js' library (For more info: <http://www.introjs.com>). This package makes it easy to include step-by-step introductions, and clickable hints in a 'Shiny' application. It supports both static introductions in the UI, and programmatic introductions from the server-side.
|
2023-06-16 |
r-rgendata
|
public |
The GenDataSample() and GenDataPopulation() functions create, respectively, a sample or population of multivariate nonnormal data using methods described in Ruscio and Kaczetow (2008). Both of these functions call a FactorAnalysis() function to reproduce a correlation matrix. The EFACompData() function allows users to determine how many factors to retain in an exploratory factor analysis of an empirical data set using a method described in Ruscio and Roche (2012). The latter function uses populations of comparison data created by calling the GenDataPopulation() function. <DOI: 10.1080/00273170802285693>. <DOI: 10.1037/a0025697>.
|
2023-06-16 |
r-rfdsn
|
public |
This package facilitates searching for and downloading seismic time series in miniSEED format (a minimalist version of the Standard for the Exchange of Earthquake Data) from International Federation of Digital Seismograph Networks repositories. This package can also be used to gather information about seismic networks (stations, channels, locations, etc) and find historical earthquake data (origins, magnitudes, etc).
|
2023-06-16 |
r-rfacebook
|
public |
Provides an interface to the Facebook API.
|
2023-06-16 |