Movatterモバイル変換
[0]ホーム
CRAN Task View: Missing Data
| Maintainer: | Julie Josse, Imke Mayer, Nicholas Tierney, Nathalie Vialaneix |
| Contact: | r-miss-tastic at clementine.wf |
| Version: | 2025-09-24 |
| URL: | https://CRAN.R-project.org/view=MissingData |
| Source: | https://github.com/cran-task-views/MissingData/ |
| Contributions: | Suggestions and improvements for this task view are very welcome and can be made through issues or pull requests on GitHub or via e-mail to the maintainer address. For further details see theContributing guide. |
| Citation: | Julie Josse, Imke Mayer, Nicholas Tierney, Nathalie Vialaneix (2025). CRAN Task View: Missing Data. Version 2025-09-24. URL https://CRAN.R-project.org/view=MissingData. |
| Installation: | The packages from this task view can be installed automatically using thectv package. For example,ctv::install.views("MissingData", coreOnly = TRUE) installs all the core packages orctv::update.views("MissingData") installs all packages that are not yet installed and up-to-date. See theCRAN Task View Initiative for more details. |
Missing data are very frequently found in datasets. Base R provides a few options to handle them using computations that involve only observed data (na.rm = TRUE in functionsmean,var, … oruse = complete.obs|na.or.complete|pairwise.complete.obs in functionscov,cor, …). The base packagestats also contains the generic functionna.action that extracts information of theNA action used to create an object. In addition, the packageie2misc contains a dyadic operator+ that behaves differently than the original+ operator regarding missing data.
These basic options are complemented by many packages on CRAN. In this task view, we focused on the most important ones, which have been published more than one year ago and are regularly updated. The task view is structured into main topics:
In addition to the present task view, thisreference website on missing data might also be helpful. Complementary information might also be found inTimeSeries,SpatioTemporal,Survival, andOfficialStatistics. Note that most packages covering temporal, and spatio-temporal interpolation and censored data are not covered by the Missing Data task view.
If you think we have missed some important packages in this list, please e-mail the maintainers or submit an issue or pull request in the GitHub repository linked above.
Exploration of missing data
- Manipulation of missing data is implemented in the packagessjmisc,sjlabelled,retroharmonize,mde (also providing basic functions to explore missingness patterns),tidyr (which abides bytidyverse principles),memisc, anddeclared. The latter is also able to compute weighted summaries including the different types of missing values. More specifically,fauxnaif converts given values to
NA andfillr fill missing values in vectors according to simple predefined rules.
roperators provides string arithmetic, reassignment operators, logical operators that handle missing values. - Missing data patterns can be identified and explored using the packagesmi (and its GUImigui),wrangle,DescTools, andnaniar.daqapo is a generic data quality toolbox that can also be used to identify missing data. More specifically,ggmice produces plots for themice imputation workflow and can be used for missing data exploration and evaluation of imputation quality.
- Graphics that describe distributions and patterns of missing data are implemented inVIM (which has a Graphical User Interface, VIMGUI, currently archived on CRAN) andnaniar (which abides bytidyverse principles).
- Tests of the MAR assumption (versus the MCAR assumption): Little’s test for the MCAR assumption is implemented inmisty. Other approaches are also available elsewhere:RBtest proposes a regression based approach to test for missing data mechanisms andPKLMtest implements a KL-based test for MCAR.
In addition,isni tests sensitivity to the ignorability assumption by computing the index of local sensitivity to nonignorability. - Evaluation:missCompare andmissMethods offer an entire framework to compare different imputation strategies (with diagnostics and visualizations). The packageIscores can also be useful to evaluate imputation quality using a KL-based scoring rule.
Simulations to evaluate imputation qualities can be performed using the functionampute ofmice, the packagesimFrame, which proposes a very general framework for simulations, or the packagesimglm, which simulates data and missing values in simple and generalized linear regression models. Similarly,imputeTestbench provides a benchmark to evaluate univariate time series imputation.
In addition,mi andVIM also provide diagnostic plots that can help evaluate imputation quality.
Likelihood based approaches
- Methods based on the Expectation Maximization (EM) algorithm are implemented innorm andmvnmle for multivariate normal datasets, incat (function
em.cat for multivariate categorical data), inmix (functionem.mix for multivariate mixed categorical and continuous data). These packages also implementBayesian approaches (with Imputation and Posterior steps) for the same models (functionsda.XXX fornorm,cat andmix) and can be used to obtain imputed complete datasets or multiple imputations (functionsimp.XXX fornorm,cat andmix), once the model parameters have been estimated.monomvn proposes similar methods for multivariate normal and Student distributions when the missingness pattern is monotonic.
CensMFM,imputeMulti, andMMDai extend these methods by using an EM approach to fit different mixtures of multivariate missing data for numeric or categorical data.RMixtCompIO is a complete library of mixture models that handles missing data and is based on the C++ libraryMixtComp. It can be used in combination withRMixtCompUtilities, which provides various graphical, getters, and utility functions.
Hierarchical Gaussian and probit models with missing covariate values are implemented inppmSuite.PReMiuM implements Dirichlet process mixture models (regression models linking the response to covariates through cluster membership) with missing covariate values.
imputeR is also using an EM based imputation framework that offers several different algorithms, including Lasso, tree-based models or PCA. In addition,TestDataImputation implements imputation based on EM estimation (and other simpler imputation methods) that are well suited for dichotomous and polytomous tests with item responses. - Multiple imputation is performed using Maximum Likelihood Multiple Imputation inmlmi.
- Full Information Maximum Likelihood (also known as “direct maximum likelihood” or “raw maximum likelihood”) is available inlavaan (and in its extensionsemTools),OpenMx,rsem, andsimsem for handling missing data in structural equation modeling.
- Bayesian approaches for handling missing values in model based clustering with variable selection is available inVarSelLCM. The package also provides imputation using the posterior mean.
- Missing values in generalized linear models can be handled with packagemdmb for various families.JointAI implements Bayesian approaches for generalized linear mixed models andbild implements logistic regression with mixed effects for binary longitudinal data allowing missing values.ClusPred also handles missing values in mixed model with a fixed group effect, when the group variable is missing.
brlrmr proposes a method to reduce bias in estimating logistic regressions with missing response. - Missing data in item response models (including Rasch models and extensions) is implemented inTAM,mirt,eRm, andltm for univariate or multivariate responses.LNIRT also addresses these models but allows missing values to be specified as “missing-by-design” andMLCIRTwithin includes latent-class models.
- Missing values in outcome of regression models is handled inmreg.
Single imputation
- The simplest method for missing data imputation isimputation by mean (or median, mode, ...). This approach is available in many packages among whichHmisc that contains various proposals for imputing with the same value all missing instances of a variable.
- Generic packages: The packagesVIM andfilling contain several popular methods for missing value imputation (including some listed in the sections dedicated to specific methods as listed below). In addition,simputation is a general package for imputation by any prediction method that can be combined with various regression methods, and works well with thetidyverse.
- k-nearest neighbors is a popular method for missing data imputation that is available in many packages including the main packagesyaImpute (with many different methods for kNN imputation, including a CCA based imputation) andVIM. It is also available inimpute (where it is oriented toward microarray imputation).
isotree uses a similar approach to impute missing values, which is based on similarities between samples and isolation forests. - Hot-deck imputation is implemented in the packagehot.deck, with various possible settings (including multiple imputation). It is also available inVIM (function
hotdeck) and a fractional version (using weights) is provided inFHDI.StatMatch also uses hot-deck imputation to impute surveys from an external dataset.
Similarly,impimp uses the notion of a “donor” to impute a set of possible values, termed “imprecise imputation”. - Imputationbased on random forest is implemented inmissForest with a faster version inmissRanger.Rforestry extend this method with variants of the original random forest method.
- Other regression based imputations are implemented inVIM (linear regression based imputation in the function
regressionImp).iai tunes optimal imputation based on knn, tree or SVM andSurrogateRegression uses bivariate regressions to perform estimation and inference on partially missing target outcomes. - Matrix completion is implemented with iterative PCA/SVD-decomposition in the packagemissMDA for numerical, categorical and mixed data (including imputation of groups).NIPALS (also based on SVD computation) is implemented in the packagesmixOmics (for PCA and PLS),ade4,nipals andplsRglm (for generalized model PLS).cmfrec is also a large package dedicated to matrix factorization (for recommender systems), which includes imputation. Other PCA/factor based imputations are available inpcaMethods (with a Bayesian implementation of PCA), inprimePCA (for heterogeneous missingness in high-dimensional PCA) andtensorBF (for 3-way tensor data).Low rank based imputation is provided insoftImpute, which contains several methods for iterative matrix completion.eimpute implements an efficient imputation methods based on low rank approximation of large matrices. Low rank imputation methods are also available in the very general packagersparse, which contains various tools for sparse matrices. Variants based on low rank assumptions are available inmimi, inECLRMC andCMF (for ensemble matrix completion), and inROptSpace (with a computationally efficient approach).
- Imputation forcategorical variables is proposed inNIMAA based on data mining and simple rules.OTrecod can also impute categorical variables by using information shared by two databases and a method based on Optimal Transport.
- Imputationbased on copula is implemented inCoImp with a semi-parametric imputation procedure and inmdgc using Gaussian copula for mixed data types.
- Imputationbased on self-organizing maps is provided inSOMbrero andmissSOM.
- Imputationbased on validation rules (deductive methods) is implemented indeductive.
Multiple imputation
Some of the above mentioned packages can also handle multiple imputations.
- Amelia implementsBootstrap multiple imputation using EM to estimate the parameters, for quantitative data it imputes assuming a Multivariate Gaussian distribution. In addition,AmeliaView is a GUI forAmelia, available from theAmelia web page.FastImputation provides a fast approximation of the imputation process used inAmelia.
NPBayesImputeCat also implements multiple imputation by joint modeling for categorical variables but using a Bayesian approach. - mi,mice, andsmcfcs implementmultiple imputation by Chained Equations. Other packages are based on or extendmice, likemiceFast, which provides an alternative implementation of mice imputation methods using object oriented style programming and C++,bootImpute, which performs bootstrap based imputations and analyses of these imputations, andmiceRanger,CALIBERrfimpute, andRfEmpImp, which all perform multiple imputation by chained equations using random forests.
- Multiple imputation based on Markov models is proposed inniaidMI.
- Dealing with multiply imputed datasets:mitools provides a generic approach to handle multiple imputation in combination with any imputation method,cobalt computes balance tables and plots for multiply imputed datasets,SynthTools provides confidence intervals for multiply imputed datasets,miceafter allows different types of statistical analyses and pooling after multiple imputation.
In addition,mitools provides a generic approach to handle multiple imputation in combination with any imputation method andcobalt computes balance tables and plots for multiply imputed datasets. - missMDA implements multiple imputation based onSVD methods.
- hot.deck implementshot-deck-based multiple imputation.
- rMIDAS implements multiple imputation based ondenoising auto-encoders.
- Multilevel imputation: Multilevel multiple imputation is implemented injomo,mice,miceadds,micemd,mitml, andpan.
- gerbil implements multiple imputation using latent joint multivariate normal models.
- Qtools implements multiple imputation based onquantile regression.
- lodi implements theimputation of observed values below the limit of detection (LOD) via censored likelihood multiple imputation (CLMI).
Weighting methods
- Computation of weights for observed data to account for unobserved data byInverse Probability Weighting (IPW) is implemented inipw andiWeigReg.nawtilus also proposes IPW computation but utilizing estimating equations suitable for a specific pre-specified parameter of interest.
- IPW is also forquantile estimations and boxplots inIPWboxplot.
- Doubly Robust Inverse Probability Weighted Augmented GEE Estimator with missing outcome is implemented inCRTgeeDR.
- IPW for time-course missing data is implemented inMIIPW.
Specific types of data
- Longitudinal data / time series data: Imputation for time series is implemented inimputeTS. Other packages, such asforecast,spacetime,timeSeries,xts,prophet,stlplus, orzoo, are dedicated to time series but also contain some (often basic) methods to handle missing data (see alsoTimeSeries). Based on tidy principle, thepadr andtsibble also provide methods for imputing missing values in time series. Similarly,DTSg offers basic functionality for missing value description and imputation in time series based on the fast
data.table framework.
More specific methods are implemented in other packages: imputation of time series based on Dynamic Time Warping is implemented in the family of packagesDTWBI, andDTWUMI.swgee implements an IPW approach for longitudinal data with missing observations.tsrobprep implements imputation of missing values using a robust decomposition of the time series.brokenstick handles missing at random data in irregular time series with a brokenstick approach.
For more specific time series,cold fits longitudinal count
models from data with missing values.
Estimation of extremal indexes in time series is implemented inexdex with K-gaps and D-gaps models that can accommodate with missing values. - Markov models:hhsmm includes various methods for hidden hybrid Markov and semi-Markov models that can accomodate missing data.
- Spatial data: Imputation for spatial data is implemented in the packagertop, which performs geostatistical interpolation of irregular areal data, and inareal, which performs areal weighted interpolation using a tidyverse data management.RcppCensSpatial estimates parameters in linear spatial models with missing data using EM, SAEM, or MCEM.
Interpolation of spatial data based on genetic distances is also available inphylin. - Spatio-temporal data (see alsoSpatioTemporal): Imputation for spatio-temporal data is implemented in the packageStempCens with a SAEM approach that approximates EM when the E-step does not have an analytic form.
From an application perspective,gapfill(archived) is dedicated to the imputation of satellite data observed at equally-spaced points in time andstfit uses Functional Principal Analysis by Conditional Estimation to impute missing pixels in satellite data.momentuHMM is dedicated to the analysis of telemetry data using generalized hidden Markov models (including multiple imputation for missing data). - Graphs/networks:missSBM imputes missing edges in Stochastic Block models,cglasso implements an extension of the Graphical Lasso inference from censored and missing value measurements, andbnstruct provides an extension of various methods for Bayesian network inference from data with missing values. Oriented toward inference of species community networks,eicm uses an extension of binomial GLM that handles missing values androbber is based on stochastic block models and also handles missing values.rnmamod includes functions to explore network meta-analysis with missing participant outcome data in clinical trials.
- Imputation for contingency tables is implemented inlori that can also be used for the analysis of contingency tables with missing data.
- Imputation for compositional data (CODA) is implemented inrobCompositions andzCompositions (various imputation methods for zeros, left-censored and missing data).
- Rank models with partially missing rankings are handled inBayesMallows with Bayesian methods, and inirrNA to compute inter-rater reliability and concordance.
- Experimental design:experiment handles missing values in experimental design such as randomized experiments with missing covariate and outcome data, and matched-pairs design with missing outcome.
- Recurrent events:dejaVu performs multiple imputation of recurrent event data based on a negative binomial regression model.
Specific tasks
- Regression and classification: many different supervised methods can accommodate the presence of missing values.randomForest,grf, andStratifiedRF handle missing values in predictors in various random forest based methods.
toweranNA handles missing values in predictions without imputation in linear model, GLM and KNN based regressions.misaem handles missing data in linear and logistic regression and allows for model selection.psfmi also provides a framework for model selection for various linear models in multiply imputed datasets andflare accommodates missing values in some models related to Lasso regression.
naivebayes provides an efficient implementation of the naive Bayes classifier in the presence of missing data.plsRbeta implements PLS for beta regression models with missing data in the predictors.lqr provides quantile regression estimates based on various distributions in the presence of missing values and censored data.eigenmodel handles missing values in regression models for symmetric relational data. - Clustering:clusterMI proposes several methods and diagnostics to handle missing data in clustering in a multiple imputation framework.RMixtComp,MGMM,mixture, andMixtureMissing fit various mixture models in the presence of missing data.ClustImpute deals with missing values in k-means clustering.gbmt performs clustering to identify similar trajectories in multivariate longitudinal data containing missing values.LUCIDus performed clustering from multiple omics when some omics are missing.miclust handles multiple imputation in clustering.
- Tests for two-sample paired missing data are implemented inrobustrank,IncomPair, andMKinfer, the latter is based on multiple imputed datasets. Reliability of tests for data with missing values is assessed with a Bayesian approach inbrxx.
- Meta-analysis:metavcov offers a collection of functions, including multiple imputations for missing data, in multivariate meta-analyses.metansue can perform meta-analysis with some missing (unreported) effects. More specifically, imputation formeta-analyses of binary outcomes is provided inmetasens provide a Bayesian analysis using network meta-analysis of dose response studies in which MNAR missing values are accounted for.
- Sensitivity analysis and confidence intervals with non-ignorable missingness patterns are handled inui.
- Outlier detection (and robust analysis) in the presence of missing values is implemented inGSE andrrcovNA.
- ROC estimation in the presence of missing values is available inbcROCsurface for ROC surface and inBLOQ for left censored data.
- Mediation analysis in the presence of missing values is implemented inbmem andbmemLavaan, the latter designed to handle non-normal data.paths uses an imputation method for the estimation of path specific effects in causal mediation analysis.
- Composite Indicator can be imputed with the packageCOINr.
- Fuzzy logic:lflcontains basic fuzzy-related algebraic functions capable of handling missing values for fuzzy logic.
- ODE: An implementation of the parameter cascade method for estimating ordinary differential equation models with missing or complete observations is provided in the packagepCODE.
Specific application fields
- Genetics: Imputation of SNP data is implemented inalleHap (using solely deterministic techniques based on pedigree data), inQTLRel (using information on flanking SNPs), insnpStats (using a nearest neighbor approach), inHardyWeinberg (using multiple imputations with a multinomial model based on allele intensities and/or flanking SNPs). In addition,SNPassoc offers functions to explore missing SNPs.
EM algorithm is used to compute genetic statistics for population in the presence of missing SNP inStAMPP and to fit genotype-to-phenotype models inFamEvent,hapassoc, andHaplin.
Finally,FILEST is used to simulate SNP datasets with outlying individuals and missing values. - Phylogeny: Imputation of missing data for phylogeny is implemented inRphylopars with different evolutionary models. Simulation of incomplete phylogeny can be performed withTreeSim.
- Genomics: Imputation for dropout events (i.e., under-sampling of mRNA molecules) in single-cell RNA-Sequencing data is implemented inDrImpute,SAVER, andiCellR, and is based, respectively, on clustering of cells, Markov affinity graph, an empirical Bayes approach, and k-nearest neighbors. The first three packages are used and combined inscRecover andADImpute and the last one can also handle other types of single-cell data, such as scATAC-Seq or CITE-Seq.
RNAseqNet uses hot-deck imputation to improve RNA-seq network inference with an auxiliary dataset. - Chemometrics:imp4p,wrProteo,mi4p,imputeLCMD andaLFQ use imputation for protein quantification from LC-MS/MS data. The first three use multiple imputation andimp4p,wrProteo, andimputeLCMD can work under an MNAR mechanism. Other packages implementing imputations for MS proteomics data are available on bioconductor, includingmsImpute (MAR and MNAR mechanisms) andProteoMM.proteDA performs differential analysis on the same type of data but implementing a probabilistic dropout model to handle missingness.
Imputation for quantified metabolomics data is implemented inlilikoi with a k-NN approach and inMAI with a two step approach where the first step aims at identifying the missingness mechanism.
Imputation of data under detection limit for NIR spectra is provided inNIRStat for standard analyses of NIR time series. - Epidemiology:sanon implements a method for the analysis of randomized clinical trials with strata that can handle MCAR data.didimputation implements treatment effect estimation and pre-trend testing in diff-in-diff designs with an imputation approach.diyar implements record linkage and epidemiological case definitions while addressing missing data across linkage stages.
More specifically,InformativeCensoring implements multiple imputation for informative censoring.pseval evaluates principal surrogates in a single clinical trial in the presence of missing counterfactual surrogate responses.sievePH implements continuous, possibly multivariate, mark-specific hazard ratio with missing values in multivariate marks using an IPW approach.icenReg performs imputation for censored responses for interval data. - Health:missingHE implements models for health economic evaluations with missing outcome data.accelmissing provides multiple imputation with the zero-inflated Poisson lognormal model for missing count values in accelerometer data.CGManalyzer provides tools for the analysis of continuous glucose monitoring that can handle missing data.qpNCA implements imputation for noncomportmental pharmacokinetic longitudinal data mostly using interpolation methods.
- Morphometry:LOST can be used to simulate missing morphometric data randomly, with taxonomic bias and with anatomical biases.
- Environment:AeRobiology imputes missing data in aerobiological datasets imported from aerobiological public databases.climatol implements functions for missing data filling of climatological series.QUALYPSO can handle missing data and provides unbiased estimates of climate change responses for incomplete ensembles of climate projections.
- Social sciences:coefficientalpha computes coefficients Alpha, social, behavioral and education sciences, in the presence of missing data.
- Causal inference: Various methods for causal inference with missing data are implemented intargeted, using augmented IPW estimators. Causal inference with interactive fixed-effect models is available ingsynth, with missing values handled by matrix completion, and indosearch, via extension of do-calculus to missing data.R6causal implements R6 class for structural causal models where the missing data mechanism can be specified.MatchThem matches multiply imputed datasets using several matching methods, and provides users with tools to estimate causal effects in each imputed dataset.grf offers treatment effect estimation with incomplete confounders and covariates under modified unconfoundedness assumptions andRCAL implements regularized calibrated estimation for causal inference with missing values and high dimension.
- Finance:imputeFin handles imputation of missing values in financial time series using AR models or random walk.
- Finance: Basic methods (mean, median, mode, ...) for imputing missing data in scoring datasets are proposed inscorecardModelUtils.creditmodel can handle missing values treatment for credit modeling.
- Preference models: Missing data in preference models are handled with a composite link approach that allows for MCAR and MNAR patterns to be accounted for inprefmod.
- Administrative records / Surveys:BIFIEsurvey is a very general package that contains tools for survey statistics and that can handle multiply imputed datasets. More specifically,fastLink provides a Fellegi-Sunter probabilistic record linkage that allows for missing data and the inclusion of auxiliary information.eatRep implements replication methods in complex survey designs comprising multiple imputed variables, andmodi provides multivariate outlier detection andconvergEU can process data from Eurostat data and impute missing values to monitor convergence between EU countries.
- Bibliometry:robustrao computes the Rao-Stirling diversity index (a well-established bibliometric indicator to measure the interdisciplinarity of scientific publications) with data containing uncategorized references.metagear provides hot-deck imputation in bibliographic data for systematic reviews and meta-analysis.
- Agriculture:geneticae implements imputation techniques for multi-environment agronomic trials.
CRAN packages
| Core: | Amelia,hot.deck,imputeTS,jomo,mice,missMDA,naniar,softImpute,VIM,yaImpute. |
| Regular: | accelmissing,ade4,AeRobiology,aLFQ,alleHap,areal,BayesMallows,bcROCsurface,BIFIEsurvey,bild,BLOQ,bmem,bmemLavaan,bnstruct,bootImpute,brlrmr,brokenstick,brxx,CALIBERrfimpute,cat,CensMFM,cglasso,CGManalyzer,climatol,ClusPred,clusterMI,ClustImpute,CMF,cmfrec,cobalt,coefficientalpha,CoImp,COINr,cold,convergEU,creditmodel,CRTgeeDR,daqapo,declared,deductive,dejaVu,DescTools,didimputation,diyar,dosearch,DrImpute,DTSg,DTWBI,DTWUMI,eatRep,ECLRMC,eicm,eigenmodel,eimpute,eRm,exdex,experiment,FamEvent,FastImputation,fastLink,fauxnaif,FHDI,FILEST,filling,fillr,flare,forecast,gbmt,geneticae,gerbil,ggmice,grf,GSE,gsynth,hapassoc,Haplin,HardyWeinberg,hhsmm,Hmisc,iai,iCellR,icenReg,ie2misc,imp4p,impimp,imputeFin,imputeLCMD,imputeMulti,imputeR,imputeTestbench,IncomPair,InformativeCensoring,ipw,IPWboxplot,irrNA,Iscores,isni,isotree,iWeigReg,JointAI,lavaan,lfl,lilikoi,LNIRT,lodi,lori,LOST,lqr,ltm,LUCIDus,MatchThem,mde,mdgc,mdmb,memisc,metagear,metansue,metasens,metavcov,MGMM,mi,mi4p,miceadds,miceafter,miceFast,micemd,miceRanger,miclust,migui,MIIPW,mimi,mirt,misaem,missCompare,missForest,missingHE,missMethods,missRanger,missSBM,missSOM,misty,mitml,mitools,mix,mixture,MixtureMissing,MKinfer,MLCIRTwithin,mlmi,MMDai,modi,momentuHMM,monomvn,mreg,mvnmle,naivebayes,nawtilus,niaidMI,NIMAA,nipals,NIRStat,norm,NPBayesImputeCat,OpenMx,OTrecod,padr,pan,paths,pCODE,phylin,PKLMtest,plsRbeta,plsRglm,ppmSuite,prefmod,PReMiuM,primePCA,prophet,pseval,psfmi,qpNCA,QTLRel,Qtools,QUALYPSO,R6causal,randomForest,RBtest,RCAL,RcppCensSpatial,retroharmonize,RfEmpImp,Rforestry,rMIDAS,RMixtComp,RMixtCompIO,RMixtCompUtilities,RNAseqNet,rnmamod,robber,robCompositions,robustrank,robustrao,roperators,ROptSpace,Rphylopars,rrcovNA,rsem,rsparse,rtop,sanon,SAVER,scorecardModelUtils,semTools,sievePH,simFrame,simglm,simputation,simsem,sjlabelled,sjmisc,smcfcs,SNPassoc,SOMbrero,spacetime,StAMPP,StatMatch,StempCens,stfit,stlplus,StratifiedRF,SurrogateRegression,swgee,SynthTools,TAM,targeted,tensorBF,TestDataImputation,tidyr,timeSeries,toweranNA,TreeSim,tsibble,tsrobprep,ui,VarSelLCM,wrangle,wrProteo,xts,zCompositions,zoo. |
| Archived: | gapfill. |
Related links
Other resources
[8]ページ先頭