Learn R Programming

⚠️There's a newer version (2.7.0) of this package.Take me there.

psychmeta

Psychometric Meta-Analysis Toolkit

Overview

The psychmeta package provides tools for computing bare-bones and psychometric meta-analyses and for generating psychometric data for use in meta-analysis simulations. Currently, the package supports bare-bones, individual-correction, and artifact-distribution methods for meta-analyzing correlations and d values. Please refer to the overview vignette vignette("overview", package = "psychmeta") for an introduction to psychmeta's functions and workflows (also found here).

Authors

psychmeta was written by Jeffrey A. Dahlke and Brenton M. Wiernik.

Installation

The official CRAN release of psychmeta can be installed with the following code:

install.packages("psychmeta")

Development versions of psychmeta from GitHub reflect updates made to the package between official CRAN releases. The GitHub release can be installed with the following code:

install.packages("remotes")
remotes::install_github("psychmeta/psychmeta")

Citing psychmeta

To cite psychmeta in your research, please refer to the package's citation information using the citation() function.

citation("psychmeta")

Reporting Issues

To report a bug or other issue, tell us about it on GitHub or email issues@psychmeta.com. For more general questions and inquiries about the package, reach out to us via Twitter or email psychmeta@psychmeta.com.

Copy Link

Version

Install

install.packages('psychmeta')

Monthly Downloads

667

Version

2.6.4

License

GPL (>= 3)

Last Published

July 11th, 2022

Functions in psychmeta (2.6.4)

adjust_n_r

Adjusted sample size for a non-Pearson correlation coefficient for use in a meta-analysis of Pearson correlations
composite_r_matrix

Matrix formula to estimate the correlation between two weighted or unweighted composite variables
composite_rel_matrix

Matrix formula to estimate the reliability of a weighted or unweighted composite variable
anova.ma_psychmeta

Wald-type tests for moderators in psychmeta meta-analyses
clean_warning

Clean warnings and remove warnings present in the environment before running the function of interest
adjust_n_d

Adjusted sample size for a non-Cohen d value for use in a meta-analysis of Cohen's d values
composite_r_scalar

Scalar formula to estimate the correlation between a composite and another variable or between two composite variables
composite_d_scalar

Scalar formula to estimate the standardized mean difference associated with a composite variable
composite_u_scalar

Scalar formula to estimate the u ratio of a composite variable
check_wt_type

Check whether wt_type argument is valid and determine which package to use for weights
compute_dmod_par

Function for computing parametric d_Modd_Mod effect sizes for any number of focal groups
conf.limits.nc.chisq

Confidence limits for noncentral chi square parameters (function and documentation from package 'MBESS' version 4.4.3) Function to determine the noncentral parameter that leads to the observed Chi.Square-value, so that a confidence interval for the population noncentral chi-squrae value can be formed.
convert_pq_to_p

Convert the dichotomous variable variance to a proportion
convert_es

Convert effect sizes
convert_ma

Function to convert meta-analysis of correlations to d values or vice-versa
compute_alpha

Compute coefficient alpha
convert_reltype2consistency

Convert string variable containing reliability type indicators to a logical variable indicating whether a reliability value is an internal-consistency estimate or a multiple-administration estimate
correct_r

Correct correlations for range restriction and/or measurement error
create_ad_group

Generate an artifact distribution object for a dichotomous grouping variable.
correct_means_mvrr

Multivariate select/correction for vectors of means
confidence

Construct a confidence interval
composite_rel_scalar

Scalar formula to estimate the reliability of a composite variable
create_ad_tibble

Create a tibble of artifact distributions by construct
composite_u_matrix

Matrix formula to estimate the u ratio of a composite variable
data_d_meas_multi

Hypothetical d value dataset simulated to satisfy the assumptions of the correction for measurement error only in multiple constructs
data_r_bvdrr

Hypothetical dataset simulated to satisfy the assumptions of the bivariate correction for direct range restriction
.print.lm_mat

Print method for objects of the class "lm_mat"
.lambda_bvirr

Internal function to produce lambda coefficients to use in the Case V correction for bivariate indirect range restriction.
data_r_mcdaniel_1994

Artifact-distribution meta-analysis of the validity of interviews
.ma_leave1out

Leave-one-out (i.e., jackknife) meta-analyses
.integrate_dmod

Integration function for computing parametric signed or unsigned d_Modd_Mod effect sizes for a single focal group
.ma_generic_boot

Internal function for computing bootstrapped bare-bones meta-analyses of generic effect sizes
confidence_r

Construct a confidence interval for correlations using Fisher's z transformation
compute_dmod_npar

Function for computing non-parametric d_Modd_Mod effect sizes for a single focal group
compute_dmod

Comprehensive d_Modd_Mod calculator
.print.summary.lm_mat

Print method for objects of the class "summary.lm_mat"
control_psychmeta

Control for psychmeta meta-analyses
convert_sdd_to_sdr

Convert the SD of d to the SD of r via TSA
data_r_mcleod_2007

Bare-bones meta-analysis of parenting and childhood depression
.ma_r_order2_bb_boot

Internal function for computing bootstrapped second-order bare-bones meta-analyses of correlations
.attenuate_r_bvirr

Internal function to undo the Case V correction for bivariate indirect range restriction
.create_ad_int

Create a tabular array of artifact information summarizing values and weights of values in an interactive artifact distribution
.ma_r_order2_ad_boot

Internal function for computing bootstrapped second-order artifact-distribution meta-analyses of correlations
.attenuate_r_bvdrr

Internal function to undo the Case V correction for bivariate indirect range restriction
.correct_r_uvirr

Internal function to compute the Case IV correction for univariate indirect range restriction
composite_d_matrix

Matrix formula to estimate the standardized mean difference associated with a weighted or unweighted composite variable
convert_consistency2reltype

Convert logical variable indicating whether a reliability value is an internal-consistency estimate or a multiple-administration estimate to a string variable of generic reliability types
confint

Confidence interval method for objects of classes deriving from "lm_mat"
estimate_matrix_prods

Estimate covariance matrices and mean vectors containing product terms
correct_r_bias

Correct correlations for small-sample bias
filter_ma

Filter meta-analyses
filter_listnonnull

Filter a list to remove NULL entries
correct_glass_bias

Correct for small-sample bias in Glass' values
correct_matrix_mvrr

Multivariate select/correction for covariance matrices
correct_r_dich

Correct correlations for artificial dichotomization of one or both variables
control_intercor

Control function to curate intercorrelations to be used in automatic compositing routine
convert_vard_to_varr

Convert the variance of d to the variance of r via TSA
convert_sdr_to_sdd

Convert the SD of r to the SD of d via TSA
format_wide

Create wide-format datasets in simulate_r_database
estimate_prod

Estimation of statistics computed from products of random, normal variables
generate_bib

Generate a list of references included in meta-analyses
data_r_uvdrr

Hypothetical dataset simulated to satisfy the assumptions of the univariate correction for direct range restriction
create_ad

Generate an artifact distribution object for use in artifact-distribution meta-analysis programs.
correct_r_coarseness

Correct correlations for scale coarseness
correct_r_split

Correct correlations for uneven/unrepresentative splits
create_ad_array

Create an array of all possible combinations of artifact values from 2-4 artifact distributions
credibility

Construct a credibility interval
convert_varr_to_vard

Convert the variance of r to the variance of d via TSA
data_d_bb_multi

Hypothetical d value dataset simulated with sampling error only
format_long

Create long-format datasets in simulate_r_database
format_num

Format numbers for presentation
ma_r

Meta-analysis of correlations
ma_generic

Bare-bones meta-analysis of generic effect sizes
.correct_r_bvdrr

Internal function to compute the correction for bivariate direct range restriction
psychmeta-package

psychmeta: Psychometric meta-analysis toolkit
correct_d

Correct d values for measurement error and/or range restriction
ma_r_ad.tsa_rb2Orig

Taylor series approximation artifact-distribution meta-analysis correcting for Raju and Burke's case 2 direct range restriction and measurement error
.correct_r_bvirr

Internal function to compute the Case V correction for bivariate indirect range restriction
data_r_gonzalezmule_2014

Meta-analysis of OCB correlations with other constructs
ma_r_ad.tsa_uvdrr

Taylor series approximation artifact-distribution meta-analysis correcting for Case II direct range restriction and measurement error
data_r_bvirr

Hypothetical dataset simulated to satisfy the assumptions of the bivariate correction for indirect range restriction
correct_d_bias

Correct for small-sample bias in Cohen's d values
data_r_uvirr

Hypothetical dataset simulated to satisfy the assumptions of the univariate correction for indirect range restriction
.correct_r_rb

Internal function to compute Raju and Burke's correction for univariate direct range restriction
psychmeta_news

Retrieve the NEWS file for the psychmeta package
.rbeta

Generate values from a beta distribution, given a mean and standard deviation of the distribution
.ma_r_order2

Internal function for computing individual-correction meta-analyses of correlations
data_r_oh_2009

Second order meta-analysis of operational validities of big five personality measures across East Asian countries
.correct_r_uvdrr

Internal function to compute the Case II correction for univariate direct range restriction
.ma_r_icvgy_boot

Internal function for computing bootstrapped individual-correction meta-analyses of validity generalization correlations for Y
.ma_r_ic_boot

Internal function for computing bootstrapped individual-correction meta-analyses of all varieties
.ma_r_ic

Internal function for computing individual-correction meta-analyses of correlations
data_r_meas

Hypothetical dataset simulated to satisfy the assumptions of the correction for measurement error only
.ma_artifacts

Internal function for computing meta-analyses of artifacts
screen_u

Screen to detect impossible values in vectors of u ratios.
ma_r_ad.tsa_bvirr

Taylor series approximation artifact-distribution meta-analysis correcting for Case V indirect range restriction and measurement error
ma_r_ad.tsa_bvdrr

Taylor series approximation artifact-distribution meta-analysis correcting for Case V indirect range restriction and measurement error
ma_r_ad.tsa_uvirr

Taylor series approximation artifact-distribution meta-analysis correcting for Case II direct range restriction and measurement error
.plot_forest_meta

Internal plotting function for forest plots
.ma_bootstrap

Wrapper function to facilitate bootstrapped meta-analyses
.tau_squared_m_solver

tau_m_squared Solver
estimate_rel_sb

Spearman-Brown prophecy formula to estimate the reliability of a lengthened measure
.tau_squared_r_solver

tau_r_squared Solver
.ma_d_bb_boot

Internal function for computing bootstrapped bare-bones meta-analyses of d values
.ma_generic

Internal function for computing bare-bones meta-analyses of generic effect sizes
.plot_funnel

Internal funnel-plot generator
estimate_u

Estimate u ratios from available artifact information
sensitivity

Sensitivity analyses for meta-analyses
generate_directory

Generate a system of folders from a file path to a new directory
.refine_var_rr

Range-restriction refinement factor (i.e., "a") for correlations' corrected sampling variances
truncate_mean

Truncation function for means
warning_variance

Warning message for invalid variances
truncate_var

Truncation function for variances
.heterogeneity

Computation of heterogeneity indices from meta-analytic results
get_stuff

Extract results from a psychmeta meta-analysis object
.attenuate_r_uvdrr

Internal function to undo the Case II correction for univariate direct range restriction
data_r_roth_2015

Artifact-distribution meta-analysis of the correlation between school grades and cognitive ability
.attenuate_r_rb

Internal function to attenuate correlations using Raju and Burke's formula for univariate direct range restriction
ma_r_order2

Second-order meta-analysis function for correlations
.ma_r_bb

Internal function for computing bare-bones meta-analyses of correlations
.identify_ma_cols

Identify meta-analysis type and provide new column names for a meta-analysis
estimate_q_dist

Estimate descriptive statistics of square-root reliabilities
organize_database

Organize a database of multi-construct or moderated information
organize_moderators

Organization of moderator data for use in meta-analyses
wt_cov

Compute weighted covariances
filter_r

Filter to detect and remove impossible values in vectors of correlations and sample sizes.
estimate_rel_dist

Estimate descriptive statistics of reliabilities
filter_r_bar

Filter to detect and remove impossible values in vectors of meta-analytic mean correlations and numbers of studies
ma_r_ad.tsa_rb2Adj

Taylor series approximation artifact-distribution meta-analysis correcting for Raju and Burke's case 2 direct range restriction and measurement error
ma_d_order2

Second-order meta-analysis function for d values
ma_d

Meta-analysis of d values
.ma_r_bb_boot

Internal function for computing bootstrapped bare-bones meta-analyses of correlations
ma_r_ad.tsa_rb1Orig

Taylor series approximation artifact-distribution meta-analysis correcting for Raju and Burke's case 1 direct range restriction and measurement error
ma_r_ad.int_rbOrig

Interactive artifact-distribution meta-analysis correcting for Case II direct range restriction and measurement error
ma_r_ad.int_rbAdj

Interactive artifact-distribution meta-analysis correcting for Case II direct range restriction and measurement error
limits_tau

Confidence limits of tau
data_r_meas_multi

Hypothetical correlation dataset simulated to satisfy the assumptions of the correction for measurement error only in multiple constructs
interval_warning

Warning message for the widths of uncertainty intervals
.ma_r_order2_ic_boot

Internal function for computing bootstrapped second-order individual-correction meta-analyses of correlations
.metabulate

Internal function for .metabulating results tables
ma_r_ad.int_uvdrr

Interactive artifact-distribution meta-analysis correcting for Case II direct range restriction and measurement error
mix_dist

Descriptive statistics for a mixture distribution
reshape_mat2dat

Extract a long-format correlation database from a correlation matrix and its supporting vectors/matrices of variable information
metareg

Compute meta-regressions
record_warnings

Summary of warning messages generated within a function
screen_r

Screen to detect impossible values in vectors of correlations and sample sizes.
.attenuate_r_uvirr

Internal function to undo the Case IV correction for univariate indirect range restriction
screen_rel

Screen to detect impossible values in vectors of reliability estimates.
simulate_psych

Simulate Monte Carlo psychometric data (observed, true, and error scores)
simulate_r_database

Simulate correlation databases of primary studies
estimate_var_rho_tsa

Taylor Series Approximation of variance of corrected for psychometric artifacts
reattribute

Copy class and attributes from the original version of an object to a modified version.
var_error_A

Estimate the error variance of the probability-based effect size (A, AUC, the common language effect size [CLES])
ma_r_ad.int_uvirr

Interactive artifact-distribution meta-analysis correcting for Case IV indirect range restriction and measurement error
ma_r_ad.tsa_meas

Taylor series approximation artifact-distribution meta-analysis correcting for measurement error
ma_r_ad.tsa_rb1Adj

Taylor series approximation artifact-distribution meta-analysis correcting for Raju and Burke's case 1 direct range restriction and measurement error
merge_simdat_r

Merge multiple "simdat_r_database" class objects
screen_ad_tsa

Screen to detect invalid Taylor series artifact distribution objects
merge_simdat_d

Merge multiple "simdat_d_database" class objects
.descriptives_database

Compute weighted descriptive statistics for a database
record_fyis

Summary of FYI messages generated within a function
screen_ad_int

Screen to detect invalid interactive artifact distribution objects
simulate_d_sample

Simulate a sample of psychometric d value data with measurement error, direct range restriction, and/or indirect range restriction
.convert_metatab

Function to convert a meta-analysis of correlations to a meta-analysis of d values or vice-versa (does one table)
.ma_cumulative

Cumulative meta-analyses
.estimate_attenuation

Estimate the compound attenuation factors (i.e., "A") for correlations
var_error_alpha

Analytic estimate of the sampling variance of coefficient
summary

Summary methods for psychmeta
simulate_matrix

Generate a list of simulated sample matrices sampled from the Wishart distribution
round2char

Round numeric values to an exact number of digits and return as a character
var_error_spearman

Estimate the error variance of Spearman rank correlations
truncate_dist

Truncation function for normal distributions (truncates both mean and variance)
estimate_var_tsa

Taylor Series Approximation of effect-size variances corrected for psychometric artifacts
heterogeneity

Supplemental heterogeneity statistics for meta-analyses
.ma_d_bb

Internal function for computing bare-bones meta-analyses of d values
var_error_u

Estimate the error variance of u ratios
impute_artifacts

Impute missing and impossible artifact values
ma_r_ad.int_bvirr

Interactive artifact-distribution meta-analysis correcting for Case V indirect range restriction and measurement error
.ma_r_icts_boot

Internal function for computing bootstrapped individual-correction meta-analyses of true-score correlations
ma_r_ad.int_bvdrr

Interactive artifact-distribution meta-analysis correcting for Case V indirect range restriction and measurement error
estimate_artifacts

Estimation of applicant and incumbent reliabilities and of true- and observed-score u ratios
estimate_length_sb

Inverse Spearman-Brown formula to estimate the amount by which a measure would have to be lengthened or shorted to achieve a desired level of reliability
estimate_var_artifacts

Taylor series approximations for the variances of estimates artifact distributions.
.ma_r_icvgx_boot

Internal function for computing bootstrapped individual-correction meta-analyses of validity generalization correlations for X
estimate_var_rho_int

Non-linear estimate of variance of corrected for psychometric artifacts using numeric integration
metabulate

Write a summary table of meta-analytic results
var_error_r_bvirr

Taylor series approximation of the sampling variance of correlations corrected using the bivariate indirect range restriction correction (Case V)
var_error_rel

Estimate the error variance of reliability estimates
predict

Prediction method for objects of classes deriving from "lm_mat"
metabulate_rmd_helper

Add metabulate equation commands and LaTeX dependencies
print

Print methods for psychmeta
filter_rel

Filter to remove impossible values from vectors of reliabilities and corresponding weights.
filter_u

Filter to remove impossible values from vectors of u ratios and corresponding weights.
limits_tau2

Confidence limits of tau-squared
lm_mat

Compute linear regression models and generate "lm" objects from covariance matrices.
ma_r_ad.int_meas

Interactive artifact-distribution meta-analysis correcting for measurement error
ma_r_ad.int_none

Null artifact distribution result: No corrections performed
mix_matrix

Estimate mixture covariance matrix from within-group covariance matrices
mix_r_2group

Estimate the mixture correlation for two groups
ma_wrapper

Wrapper function to compute meta-analytic results for all analyses.
manage_arglength

Check the length of x against the length of y and replicate z if necessary
plot_forest

Create forest plots
scalar_arg_warning

Warning message for scalar arguments receiving multiple values
sparsify_simdat_r

Create sparse artifact information in a "simdat_r_database" class object
summarize_ads

Summarize artifact information from meta-analyses into table format
wt_dist

Weighted descriptive statistics for a vector of numbers
reshape_vec2mat

Assemble a variance-covariance matrix
plot_funnel

Create funnel plots
unmix_r_2group

Estimate the average within-group correlation from a mixture correlation for two groups
unmix_matrix

Estimate average within-group covariance matrices from a mixture covariance matrix
simulate_alpha

Generate a vector of simulated sample alpha coefficients
simulate_d_database

Simulate d value databases of primary studies
var_error_g

Estimate the error variance Hedges's g values
reshape_wide2long

Reshape database from wide format to long format
simulate_r_sample

Simulation of data with measurement error and range-restriction artifacts
sparsify_simdat_d

Create sparse artifact information in a "simdat_d_database" class object
var_error_delta

Estimate the error variance of Glass's values
var_error_d

Estimate the error variance Cohen's d values
var_error_q

Estimate the error variance of square roots of reliability estimates
var_error_r

Estimate the error variance of correlations
var_error_mult_R

Estimate the error variance of linear regression multiple R(-squared)