| Type: | Package | 
| Title: | Scrubbing and Other Data Cleaning Routines for fMRI | 
| Version: | 0.14.5 | 
| Maintainer: | Amanda Mejia <mandy.mejia@gmail.com> | 
| Description: | Data-driven fMRI denoising with projection scrubbing (Pham et al (2022) <doi:10.1016/j.neuroimage.2023.119972>). Also includes routines for DVARS (Derivatives VARianceS) (Afyouni and Nichols (2018) <doi:10.1016/j.neuroimage.2017.12.098>), motion scrubbing (Power et al (2012) <doi:10.1016/j.neuroimage.2011.10.018>), aCompCor (anatomical Components Correction) (Muschelli et al (2014) <doi:10.1016/j.neuroimage.2014.03.028>), detrending, and nuisance regression. Projection scrubbing is also applicable to other outlier detection tasks involving high-dimensional data. | 
| Depends: | R (≥ 3.5.0) | 
| License: | GPL-3 | 
| Encoding: | UTF-8 | 
| Imports: | MASS, cellWise, e1071, fMRItools (≥ 0.2.2), pesel, robustbase, stats, expm, utils, gamlss | 
| Suggests: | corpcor, cowplot, ciftiTools, gifti, knitr, rmarkdown, RNifti, ggplot2, fastICA, oro.nifti, testthat (≥ 3.0.0), covr | 
| RoxygenNote: | 7.2.3 | 
| URL: | https://github.com/mandymejia/fMRIscrub | 
| BugReports: | https://github.com/mandymejia/fMRIscrub/issues | 
| LazyData: | true | 
| NeedsCompilation: | no | 
| Packaged: | 2023-10-24 21:50:22 UTC; ddpham | 
| Author: | Amanda Mejia [aut, cre],
  John Muschelli | 
| Repository: | CRAN | 
| Date/Publication: | 2023-10-25 07:00:02 UTC | 
DVARS
Description
Computes the DSE decomposition and DVARS-related statistics. Based on code from github.com/asoroosh/DVARS .
Usage
DVARS(
  X,
  normalize = TRUE,
  cutoff_DPD = 5,
  cutoff_ZD = qnorm(1 - 0.05/nrow(as.matrix_ifti(X))),
  verbose = FALSE
)
Arguments
| X | a  | 
| normalize | Normalize the data? Default:  To replicate Afyouni and Nichols' procedure for the HCP MPP data, since the HCP scans are already normalized to 10,000, just divide the data by 100 and center the voxels on their means: 
 Note that while voxel centering doesn't affect DVARS, it does affect DPD and ZD. | 
| cutoff_DPD,cutoff_ZD | Numeric outlier cutoffs. Timepoints exceeding these cutoffs will be flagged as outliers. | 
| verbose | Should occasional updates be printed? Default is  | 
Value
A list with components
- measure
- A data.frame with - Trows, each column being a different variant of DVARS.
- measure_info
- "DVARS" 
- outlier_cutoff
- The outlier cutoff value(s). 
- outlier_flag
- A logical data.frame with - Trows, where- TRUEindicates suspected outlier presence.
References
- Afyouni, S. & Nichols, T. E. Insight and inference for DVARS. NeuroImage 172, 291-312 (2018). 
First Example Time Series from the ABIDE
Description
A sagittal slice from the fMRI time series for subject 0050048. The scan was obtained at the University of Pittsburgh School of Medicine. The scan has been pre-processed with slice time correction, rigid body realignment estimation, spatial normalization to MNI space, and linear detrending. Subject 0050048 was a typically-developing 11-year-old male. The scan has many artifacts. A mask was applied to vectorize the spatial dimensions.
Usage
Dat1
Format
A numeric matrix of 193 time points by 4675 voxels
Details
Source: http://fcon_1000.projects.nitrc.org/indi/abide/abide_I.html
References
- 1.Di Martino, A. et al. The autism brain imaging data exchange: towards a large-scale evaluation of the intrinsic brain architecture in autism. Mol Psychiatry 19, 659–667 (2014). 
Second Example Time Series from the ABIDE
Description
A sagittal slice from the fMRI time series for subject 0051479. The scan was obtained at the California Institute of Technology. The scan has been pre-processed with slice time correction, rigid body realignment estimation, spatial normalization to MNI space, and linear detrending. Subject 0051479 was a typically-developing 20-year-old female. The scan has few visible artifacts. A mask was applied to vectorize the spatial dimensions.
Usage
Dat2
Format
A numeric matrix of 145 time points by 4679 voxels
Details
Source: http://fcon_1000.projects.nitrc.org/indi/abide/abide_I.html
References
- 1.Di Martino, A. et al. The autism brain imaging data exchange: towards a large-scale evaluation of the intrinsic brain architecture in autism. Mol Psychiatry 19, 659–667 (2014). 
Framewise Displacement
Description
Calculate Framewise Displacement (FD)
Usage
FD(
  X,
  trans_units = c("mm", "cm", "in"),
  rot_units = c("deg", "rad", "mm", "cm", "in"),
  brain_radius = NULL,
  detrend = FALSE,
  lag = 1,
  cutoff = 0.3
)
Arguments
| X | An  Alternatively, this can be the file path to an  | 
| trans_units | 
 | 
| rot_units | 
 | 
| brain_radius | If  If  | 
| detrend | Detrend each RP with the DCT before computing FD?
Default:  | 
| lag | The difference of indices between which to calculate change in
position. Default:  | 
| cutoff | FD values higher than this will be flagged. Default:  | 
Details
The FD formula is taken from Power et. al. (2012):
FD_i = | \Delta x_i | + | \Delta y_i | + | \Delta z_i | + | \Delta \alpha_i | + | \Delta \beta_i | + | \Delta \gamma_i |
where i is the timepoint; x, y and z are the
translational realignment parameters (RPs);
\alpha, \beta and \gamma are the rotational RPs;
and \Delta x_i = x_{i-1} - x_i (and similarly for the other RPs).
Value
A list with components
- measure
- A length - Nvector of FD values in- trans_units.
- measure_info
- "FD" 
- outlier_cutoff
- cutoff
- outlier_flag
- A length-N logical vector, where - TRUEindicates suspected outlier presence.
References
- Power, J. D., Barnes, K. A., Snyder, A. Z., Schlaggar, B. L. & Petersen, S. E. Spurious but systematic correlations in functional connectivity MRI networks arise from subject motion. Neuroimage 59, 2142-2154 (2012). 
Impute outliers for robust distance
Description
Impute the outliers for robust distance.
Usage
RD_impData(data, univOut)
Arguments
| data | The data | 
| univOut | The univariate outliers | 
Value
The data with imputed outliers.
Robust distance calculation
Description
Compute robust distance
Usage
RD_meas(data, ind_incld, dist = TRUE)
Arguments
| data | The dimension reduced and selected data. | 
| ind_incld | Indices of the included subset of  | 
| dist | Compute the robust distances? Default:  | 
Value
A list with parameters and optionally the robust distances.
Univariate outlier detection for robust distance
Description
Identify the univariate outliers with robust distance.
Usage
RD_univOut(data, cutoff = 4, trans = c("none", "robust-YJ", "SHASH"))
Arguments
| data | The data | 
| cutoff | Default:  | 
| trans | Transform the data? Default:  | 
Value
The univariate outliers.
Robust outlier detection based on SHASH distribution
Description
A robust outlier detection based on modeling the data as coming from a SHASH distribution.
Usage
SHASH_out(x, maxit = 20, out_lim = 3, weight_init = NULL)
Arguments
| x | The numeric vector in which to detect outliers. | 
| maxit | The maximum number of iterations. Default:  | 
| out_lim | SD threshold for outlier flagging. Default:  | 
| weight_init | Initial weights. Default:  | 
Value
A "SHASH_out" object, i.e. a list with components
- out_idx
- Indices of the detected outliers. 
- x_norm
- The normalized data. 
- SHASH_coef
- Coefficients for the SHASH-to-normal transformation. 
- indx_iters
- TRUE for the detected outliers for each itertation. 
- last_iter
- Last iteration number. 
- converged
- Logical indicating whether the convergence criteria was satisfied or not. 
Examples
x <- rnorm(100) + (seq(100)/200)
x[77] <- 13
SHASH_out(x)
SHASH to normal data transformation
Description
Transform SHASH-distributed data to normal-distributed data.
Usage
SHASH_to_normal(x, mu, sigma, nu, tau, inverse = FALSE)
Arguments
| x | Numeric vector of data to transform. | 
| mu | Parameter that modulates the mean of  | 
| sigma | Parameter that modulates the variance of  | 
| nu | Parameter that modulates the skewness of  | 
| tau | Parameter that modulates the tailweight of  | 
| inverse | Transform normal data to SHASH instead? Default:  | 
Value
The transformed data.
Artifact images
Description
Visualize artifact patterns from the results of pscrub.
Requires pscrub(..., get_dirs=TRUE).
Usage
artifact_images(psx, idx = NULL, use_dt = TRUE)
Arguments
| psx | A  | 
| idx | The timepoints or column indexes for which to compute artifact
images. If  | 
| use_dt | If detrended components are available (the "U" matrix of PCA
or "M" matrix of ICA), should they be used to compute the artifact images?
Otherwise, use the non-detrended components. Default:  | 
Details
Computes two types: "mean" artifact images based on a weighted sum of the projection directions, with weights determined by the scores for each component at the flagged timepoint, and "top" artifact images based on the projection direction with the greatest score at the flagged timepoint.
Value
A list of three: idx, the timepoints for which the artifact images
were computed; mean, the "mean" artifact images; and top, the
"top" artifact images. The row names of the top artifact images
matrix give the index of the top component ("V" in PCA and "S" in ICA) at
each timepoint.
fMRI data for scrub and CompCor
Description
fMRI data for scrub and CompCor
Arguments
| X | Wide numeric data matrix ( Or, a 4D array or NIFTI or file path to a NIFTI ( Or, a  | 
| ROI_data | Indicates the data ROI. Allowed arguments depend on  If  If  If  If  | 
| ROI_noise | Indicates the noise ROIs for aCompCor. Should be a list where
each entry corresponds to a distinct noise ROI. The names of the list should
be the ROI names, e.g.  For all types of  If  If  (If  | 
Robust empirical rule
Description
Robust empirical rule outlier detection applicable to approximately Normal data
Usage
emprule_rob(x, thr = 4)
Arguments
| x | The data | 
| thr | MAD threshold | 
Value
Logical vector indicating whether each element in x is an
outlier (TRUE if an outlier).
fMRIscrub: fMRI scrubbing and other data cleaning routines
Description
See help(package="fMRIscrub") for a list of functions.
Flags to nuisance spikes
Description
Convert flagged volumes to corresponding one-hot encoded vectors which can be used for nuisance regression.
Usage
flags_to_nuis_spikes(flags, n_time)
Arguments
| flags | Numeric vector of integers indicating the indices of
the flagged volumes. Or, a logical vector of length  | 
| n_time | The length of the vectors to obtain. For nuisance regression,
this is the length of the BOLD data. The highest index in  | 
Value
A numeric matrix of ones and zeroes. The number of rows will be
n_time and the number of columns will be the number of flags. Each
column will have a 1 at the flag index, and 0 elsewhere.
Which components have high kurtosis?
Description
The kurtosis cutoff is a high quantile (default 0.99) of the sampling distribution of kurtosis for Normal iid data of the same length as the components; it is estimated by simulation or calculated from the theoretical asymptotic distribution if the components are long enough.
Usage
high_kurtosis(Comps, kurt_quantile = 0.99, n_sim = 5000, min_1 = FALSE)
Arguments
| Comps | A matrix; each column is a component. For PCA, this is the U matrix. For ICA, this is the M matrix. | 
| kurt_quantile | components with kurtosis of at least this quantile are kept. | 
| n_sim | The number of simulation data to use for estimating the sampling
distribution of kurtosis. Only used if a new simulation is performed. (If
 | 
| min_1 | Require at least one component to be selected? In other words, if
no components meet the quantile cutoff, should the component with the highest
kurtosis be returned? Default:  | 
Details
The components should not have any strong low-frequency trends, because trends can affect kurtosis in unpredictable ways unrelated to outlier presence.
Value
A logical vector indicating whether each component has high kurtosis.
Leverage
Description
Computes the leverage of each observation in the PC score (U) or IC mixing (M) matrix for projection scrubbing. Can threshold to flag potential outliers.
Usage
leverage(Comps, are_norm = FALSE, median_cutoff = NULL)
Arguments
| Comps | The  | 
| are_norm | Assume the columns of  | 
| median_cutoff | The outlier cutoff, in multiples of the median leverage.
Default:  | 
Value
A list with entries "meas" (the leverage values),
"cut" (the leverage cutoff value) and
"flag" (logical vector indicating the outliers). If
!is.null(median_cutoff), "cut" and "flag" are omitted.
noise parameters for CompCor
Description
noise parameters for CompCor
Arguments
| noise_nPC | The number of principal components to compute for each noise ROI. Alternatively, values between 0 and 1, in which case they will represent the minimum proportion of variance explained by the PCs used for each noise ROI. The smallest number of PCs will be used to achieve this proportion of variance explained. Should be a list or numeric vector with the same length as  | 
| noise_erosion | The number of voxel layers to erode the noise ROIs by.
Should be a list or numeric vector with the same length as  | 
Plot a "scrub_DVARS" object
Description
Plot a "scrub_DVARS" object
Usage
## S3 method for class 'scrub_DVARS'
plot(x, title = NULL, ...)
Arguments
| x | The  | 
| title | (Optional) If provided, will add a title to the plot. | 
| ... | Additional arguments to ggplot, e.g.  | 
Value
A ggplot
Plot a "scrub_FD" object
Description
Plot a "scrub_FD" object
Usage
## S3 method for class 'scrub_FD'
plot(x, title = NULL, ...)
Arguments
| x | The  | 
| title | (Optional) If provided, will add a title to the plot. | 
| ... | Additional arguments to ggplot, e.g.  | 
Value
A ggplot
Plot a "scrub_projection" object
Description
Plot a "scrub_projection" object
Usage
## S3 method for class 'scrub_projection'
plot(x, title = NULL, ...)
Arguments
| x | The  | 
| title | (Optional) If provided, will add a title to the plot. | 
| ... | Additional arguments to ggplot, e.g.  | 
Value
A ggplot
Plot a "scrub_projection_multi" object
Description
Plot a "scrub_projection_multi" object
Usage
## S3 method for class 'scrub_projection_multi'
plot(x, title = NULL, ...)
Arguments
| x | The  | 
| title | (Optional) If provided, will add a title to the plot. | 
| ... | Additional arguments to ggplot, e.g.  | 
Value
A ggplot
Plot scrubbing results
Description
Plot a leverage, DVARS, or FD timeseries from a "scrub_projection",
"scrub_DVARS", or "scrub_FD" object, respectively. Highlight
volumes flagged for outlier presence.
Usage
plot_scrub_wrapper(x, title = NULL, ...)
Arguments
| x | The  | 
| title | (Optional) If provided, will add a title to the plot. | 
| ... | Additional arguments to ggplot, e.g.  | 
Value
A ggplot
Get internal name of this projection
Description
Get name of projection given PESEL & kurtosis.
Usage
projection_name(projection, PESEL, kurt_quantile)
Arguments
| projection,PESEL,kurt_quantile | See  | 
Value
The name of the projection
Projection scrubbing
Description
Projection scrubbing is a data-driven method for identifying artifact-contaminated volumes in fMRI. It works by identifying component directions in the data likely to represent patterns of burst noise, and then computing a composite measure of outlyingness based on leverage within these directions, at each volume. The projection can be PCA, ICA, or "fused PCA." Projection scrubbing can also be used for other outlier detection tasks involving high-dimensional data.
Usage
pscrub(
  X,
  projection = c("ICA", "PCA"),
  nuisance = "DCT4",
  center = TRUE,
  scale = TRUE,
  comps_mean_dt = FALSE,
  comps_var_dt = FALSE,
  PESEL = TRUE,
  kurt_quantile = 0.99,
  get_dirs = FALSE,
  full_PCA = FALSE,
  get_outliers = TRUE,
  cutoff = 4,
  seed = 0,
  ICA_method = c("C", "R"),
  verbose = FALSE
)
Arguments
| X | Wide numeric data matrix ( | 
| projection | One of the following:  | 
| nuisance | Nuisance signals to regress from each column of  Detrending is highly recommended for time-series data, especially if there are many time points or evolving circumstances affecting the data. Additionally, if kurtosis is being used to select the projection directions, trends can induce positive or negative kurtosis, contaminating the connection between high kurtosis and outlier presence. Detrending should not be used with non-time-series data because the observations are not temporally related. Additional nuisance regressors can be specified like so:
 | 
| center,scale | Center the columns of the data by their medians, and scale the
columns of the data by their median absolute deviations (MADs)? Default:  Note that centering and scaling occur after nuisance regression, so even if
 | 
| comps_mean_dt,comps_var_dt | Stabilize the mean and variance of each
projection component's timecourse prior to computing kurtosis and leverage?
These arguments should be  Slow-moving mean and variance patterns in the components will interfere with
the roles of kurtosis and leverage in identifying outliers. While
 Overall, for fMRI we recommend enabling  | 
| PESEL | Use  | 
| kurt_quantile | What quantile cutoff should be used to select the
components? Default:  We model each component as a length  | 
| get_dirs | Should the projection directions be returned? This is the
 | 
| full_PCA | Only applies to the PCA projection. Return the full SVD?
Default:  | 
| get_outliers | Should outliers be flagged based on  | 
| cutoff | Median leverage cutoff value. Default:  | 
| seed | Set a seed right before the call to  | 
| ICA_method | The  | 
| verbose | Should occasional updates be printed? Default:  | 
Details
Refer to the projection scrubbing vignette for a demonstration and an
outline of the algorithm: vignette("projection_scrubbing", package="fMRIscrub")
Value
A "pscrub" object, i.e. a list with components
- measure
- A numeric vector of leverage values. 
- outlier_cutoff
- The numeric outlier cutoff value ( - cutofftimes the median leverage).
- outlier_flag
- A logical vector where - TRUEindicates where leverage exceeds the cutoff, signaling suspected outlier presence.
- mask
- 
A length Pnumeric vector corresponding to the data locations inX. Each value indicates whether the location was masked:- 0
- The data location was not masked out. 
- -1
- The data location was masked out, because it had at least one - NAor- NaNvalue.
- -2
- The data location was masked out, because it was constant. 
 
- PCA
- 
This will be a list with components: - U
- The - Tby- QPC score matrix.
- D
- The standard deviation of each PC. 
- V
- The - Pby- QPC directions matrix. Included only if- get_dirs.
- highkurt
- The length - Qlogical vector indicating scores of high kurtosis.
- U_dt
- Detrended components of - U. Included only if components were mean- or variance-detrended.
- highkurt
- The length - Qlogical vector indicating detrended scores of high kurtosis.
- nPCs_PESEL
- The number of PCs selected by PESEL. 
- nPCs_avgvar
- The number of above-average variance PCs. 
 where Qis the number of PCs selected by PESEL or of above-average variance (or the greater of the two if both were used). If PCA was not used, all entries exceptnPCs_PESELand/ornPCs_avgvarwill not be included, depending on which method(s) was used to select the number of PCs.
- ICA
- 
If ICA was used, this will be a list with components: - S
- The - Pby- Qsource signals matrix. Included only if- get_dirs
- M
- The - Tby- Qmixing matrix.
- highkurt
- The length - Qlogical vector indicating mixing scores of high kurtosis.
- M_dt
- Detrended components of - M. Included only if components were mean- or variance-detrended.
- highkurt
- The length - Qlogical vector indicating detrended mixing scores of high kurtosis. Included only if components were mean- or variance-detrended.
 
References
- Mejia, A. F., Nebel, M. B., Eloyan, A., Caffo, B. & Lindquist, M. A. PCA leverage: outlier detection for high-dimensional functional magnetic resonance imaging data. Biostatistics 18, 521-536 (2017). 
- Pham, D., McDonald, D., Ding, L., Nebel, M. B. & Mejia, A. Less is more: balancing noise reduction and data retention in fMRI with projection scrubbing. (2022). 
Examples
library(fastICA)
psx = pscrub(Dat1[seq(70),seq(800,950)], ICA_method="R")
pscrub
Description
pscrub
Arguments
| X | Wide numeric data matrix ( | 
| nuisance | Nuisance signals to regress from each column of  Detrending is highly recommended for time-series data, especially if there are many time points or evolving circumstances affecting the data. Additionally, if kurtosis is being used to select the projection directions, trends can induce positive or negative kurtosis, contaminating the connection between high kurtosis and outlier presence. Detrending should not be used with non-time-series data because the observations are not temporally related. Additional nuisance regressors can be specified like so:
 | 
| center,scale | Center the columns of the data by their medians, and scale the
columns of the data by their median absolute deviations (MADs)? Default:  Note that centering and scaling occur after nuisance regression, so even if
 | 
| comps_mean_dt,comps_var_dt | Stabilize the mean and variance of each
projection component's timecourse prior to computing kurtosis and leverage?
These arguments should be  Slow-moving mean and variance patterns in the components will interfere with
the roles of kurtosis and leverage in identifying outliers. While
 Overall, for fMRI we recommend enabling  | 
| kurt_quantile | What quantile cutoff should be used to select the
components? Default:  We model each component as a length  | 
| get_dirs | Should the projection directions be returned? This is the
 | 
| full_PCA | Only applies to the PCA projection. Return the full SVD?
Default:  | 
| get_outliers | Should outliers be flagged based on  | 
| cutoff | Median leverage cutoff value. Default:  | 
| verbose | Should occasional updates be printed? Default:  | 
| seed | Set a seed right before the call to  | 
| ICA_method | The  | 
Convert "pscrub_multi" to "pscrub"
Description
Convert "pscrub_multi" to "pscrub"
Usage
pscrub_from_multi(psx)
Arguments
| psx | The  | 
Value
The resulting "pscrub" object
Compare projection scrubbing measures with pscrub_multi
Description
Calculates leverage to identify outliers in high-dimensional data. Can get results using multiple kinds of projections.
Usage
pscrub_multi(
  X,
  projection = "ICA_kurt",
  nuisance = "DCT4",
  center = TRUE,
  scale = TRUE,
  comps_mean_dt = FALSE,
  comps_var_dt = FALSE,
  kurt_quantile = 0.99,
  get_dirs = FALSE,
  full_PCA = FALSE,
  get_outliers = TRUE,
  cutoff = 4,
  seed = 0,
  ICA_method = c("C", "R"),
  verbose = FALSE
)
Arguments
| X | Wide numeric data matrix ( | 
| projection | Projection scrubbing projects the data onto directions likely to contain outlier information. Choose at least one of the following: 
 where  Use  | 
| nuisance | Nuisance signals to regress from each column of  Detrending is highly recommended for time-series data, especially if there are many time points or evolving circumstances affecting the data. Additionally, if kurtosis is being used to select the projection directions, trends can induce positive or negative kurtosis, contaminating the connection between high kurtosis and outlier presence. Detrending should not be used with non-time-series data because the observations are not temporally related. Additional nuisance regressors can be specified like so:
 | 
| center,scale | Center the columns of the data by their medians, and scale the
columns of the data by their median absolute deviations (MADs)? Default:  Note that centering and scaling occur after nuisance regression, so even if
 | 
| comps_mean_dt,comps_var_dt | Stabilize the mean and variance of each
projection component's timecourse prior to computing kurtosis and leverage?
These arguments should be  Slow-moving mean and variance patterns in the components will interfere with
the roles of kurtosis and leverage in identifying outliers. While
 Overall, for fMRI we recommend enabling  | 
| kurt_quantile | What quantile cutoff should be used to select the
components? Default:  We model each component as a length  | 
| get_dirs | Should the projection directions be returned? This is the
 | 
| full_PCA | Only applies to the PCA projection. Return the full SVD?
Default:  | 
| get_outliers | Should outliers be flagged based on  | 
| cutoff | Median leverage cutoff value. Default:  | 
| seed | Set a seed right before the call to  | 
| ICA_method | The  | 
| verbose | Should occasional updates be printed? Default:  | 
Value
A "pscrub_multi" object, i.e. a list with components
- measure
- A - Tby- Pdata.frame of numeric leverage values, each column being the leverage values for a projection method in- projection.
- measure_info
- A data.frame with - Prows listing information about each projection used.
- outlier_cutoff
- A - 1by- Pdata.frame of numeric outlier cutoff values for each projection (- cutofftimes the median leverage).
- outlier_flag
- A - Tby- Pdata.frame of logical values where- TRUEindicates where leverage exceeds the cutoff, signaling suspected outlier presence.
- mask
- 
A length Pnumeric vector corresponding to the data locations inX. Each value indicates whether the location was masked:- 1
- The data location was not masked out. 
- -1
- The data location was masked out, because it had at least one - NAor- NaNvalue.
- -2
- The data location was masked out, because it was constant. 
 
- PCA
- 
This will be a list with components: - U
- The - Tby- QPC score matrix.
- D
- The standard deviation of each PC. 
- V
- The - Pby- QPC directions matrix. Included only if- get_dirs.
- highkurt
- The length - Qlogical vector indicating scores of high kurtosis.
- U_dt
- Detrended components of - U. Included only if components were mean- or variance-detrended.
- highkurt
- The length - Qlogical vector indicating detrended scores of high kurtosis.
- nPCs_PESEL
- The number of PCs selected by PESEL. 
- nPCs_avgvar
- The number of above-average variance PCs. 
 where Qis the number of PCs selected by PESEL or of above-average variance (or the greater of the two if both were used). If PCA was not used, all entries exceptnPCs_PESELand/ornPCs_avgvarwill not be included, depending on which method(s) was used to select the number of PCs.
- ICA
- 
If ICA was used, this will be a list with components: - S
- The - Pby- Qsource signals matrix. Included only if- get_dirs
- M
- The - Tby- Qmixing matrix.
- highkurt
- The length - Qlogical vector indicating mixing scores of high kurtosis.
- M_dt
- Detrended components of - M. Included only if components were mean- or variance-detrended.
- highkurt
- The length - Qlogical vector indicating detrended mixing scores of high kurtosis. Included only if components were mean- or variance-detrended.
 
Stabilize the center and scale of a timeseries robustly
Description
Stabilize the center and scale of a timeseries using robust regression of DCT bases on the first and second moments.
Usage
rob_stabilize(
  x,
  center = TRUE,
  scale = TRUE,
  lmrob_method = "MM",
  rescale = TRUE
)
Arguments
| x | The timeseries to stabilize. | 
| center,scale | Center and scale? Default:  | 
| lmrob_method | The  | 
| rescale | After stabilizing  | 
Value
the timeseries with its center and scale stabilized
Robust linear model on DCT bases
Description
Fit a linear model regressing an input vector on DCT bases, robustly.
Usage
rob_trend(x, nDCT = 4, lmrob_method = "MM", seed = 0)
Arguments
| x | The input vector to regress on DCT bases | 
| nDCT | The number of DCT bases to use. Default:  | 
| lmrob_method | The  | 
| seed | Set a seed right before the call to  | 
Value
The output of robustbase::lmrob
Robust distance scrubbing
Description
Scrubbing with robust distance.
Usage
robdist(
  X,
  RD_cutoff = 4,
  RD_quantile = 0.99,
  trans = c("none", "robust-YJ", "SHASH"),
  bootstrap_n = 1000,
  bootstrap_alpha = 0.01,
  projection = c("ICA", "PCA"),
  nuisance = "DCT4",
  center = TRUE,
  scale = TRUE,
  comps_mean_dt = FALSE,
  comps_var_dt = FALSE,
  PESEL = TRUE,
  kurt_quantile = 0.99,
  get_dirs = FALSE,
  full_PCA = FALSE,
  get_outliers = TRUE,
  cutoff = 4,
  seed = 0,
  ICA_method = c("C", "R"),
  skip_dimred = FALSE,
  verbose = FALSE
)
Arguments
| X | Wide numeric data matrix ( | 
| RD_cutoff | Default:  | 
| RD_quantile | Quantile cutoff...? | 
| trans | Apply a transformation prior to univariate outlier detection?
Three options:  | 
| bootstrap_n | Use bootstrapping to estimate the robust distance null
distribution? If so, set this to the number of bootstraps. Default:
 | 
| bootstrap_alpha | If using bootstrap ( | 
| projection | One of the following:  | 
| nuisance | Nuisance signals to regress from each column of  Detrending is highly recommended for time-series data, especially if there are many time points or evolving circumstances affecting the data. Additionally, if kurtosis is being used to select the projection directions, trends can induce positive or negative kurtosis, contaminating the connection between high kurtosis and outlier presence. Detrending should not be used with non-time-series data because the observations are not temporally related. Additional nuisance regressors can be specified like so:
 | 
| center,scale | Center the columns of the data by their medians, and scale the
columns of the data by their median absolute deviations (MADs)? Default:  Note that centering and scaling occur after nuisance regression, so even if
 | 
| comps_mean_dt,comps_var_dt | Stabilize the mean and variance of each
projection component's timecourse prior to computing kurtosis and leverage?
These arguments should be  Slow-moving mean and variance patterns in the components will interfere with
the roles of kurtosis and leverage in identifying outliers. While
 Overall, for fMRI we recommend enabling  | 
| PESEL | Use  | 
| kurt_quantile | What quantile cutoff should be used to select the
components? Default:  We model each component as a length  | 
| get_dirs | Should the projection directions be returned? This is the
 | 
| full_PCA | Only applies to the PCA projection. Return the full SVD?
Default:  | 
| get_outliers | Should outliers be flagged based on  | 
| cutoff | Median leverage cutoff value. Default:  | 
| seed | Set a seed right before the call to  | 
| ICA_method | The  | 
| skip_dimred | Skip dimension reduction? Default:  | 
| verbose | Should occasional updates be printed? Default:  | 
Value
A "robdist" object, i.e. a list with components
- lwr_50
- ... 
- lwr_80
- ... 
- B_quant
- ... 
Examples
library(fastICA)
rdx = robdist(Dat1[seq(70),seq(800,950)])
Data-driven scrubbing
Description
Performs projection scrubbing or DVARS scrubbing, and optionally thresholds to identify artifactual time points.
Usage
scrub(X, method = c("projection", "DVARS"), ...)
Arguments
| X | A  | 
| method | 
 | 
| ... | Additional arguments to the specific scrubbing function: see
 | 
Value
A list with components
- measure
- A length - Tvector or data.frame with- Trows, giving the outlyingness measure(s)
- measure_info
- Describes the outlyingness measure(s) 
- outlier_cutoff
- The outlier cutoff value(s). 
- outlier_flag
- A length - Tvector or data.frame with- Trows, where- TRUEindicates suspected outlier presence.
"scrub" plot sub-function
Description
Plot outlyingness measure(s) with the corresponding threshold(s). Requires
the cowplot and ggplot2 packages
Usage
scrub_plot(
  meas,
  cut = NULL,
  flag_intersect = FALSE,
  colors = NULL,
  log_y = FALSE,
  geom = "point",
  ylim_min = 0,
  ylim_max = max(meas$measure),
  ...
)
Arguments
| meas | A  | 
| cut | A length  | 
| flag_intersect | Only flag timepoints at which all measures are outliers?
Default:  | 
| colors | A length  | 
| log_y | Use log scale for y-axis? Default:  | 
| geom | "point" (default) or "line" | 
| ylim_min,ylim_max | The range of the y-axis. | 
| ... | Additional arguments to ggplot: main, sub, xlab, ... | 
Value
A ggplot
Scrub fMRI data in CIFTI format
Description
Performs projection scrubbing or DVARS scrubbing, and optionally thresholds
to identify artifactual time points. Requires ciftiTools and the
Connectome Workbench.
Usage
scrub_xifti(
  X,
  method = c("projection", "DVARS"),
  brainstructures = c("left", "right"),
  ...
)
Arguments
| X | Path to a CIFTI file, or a  | 
| method | 
 | 
| brainstructures | Character vector indicating which brain structure(s)
to use:  | 
| ... | Additional arguments to each specific scrubbing function:
 | 
Value
A list with components
- measure
- A length - Tvector or data.frame with- Trows, giving the outlyingness measure(s)
- measure_info
- Describes the outlyingness measure(s) 
- outlier_cutoff
- The outlier cutoff value(s). 
- outlier_flag
- A length - Tvector or data.frame with- Trows, where- TRUEindicates suspected outlier presence.
Estimate SD robustly using the half IQR
Description
Estimates standard deviation robustly using the half IQR (and power trans.). Used to measure DVARS in Afyouni and Nichols, 2018.
Usage
sd_hIQR(x, d = 1)
Arguments
| x | Numeric vector of data to estimate standard deviation for. | 
| d | The scalar power transformation parameter.  | 
Value
Scalar for the robust estimate of standard deviation.
Summarize a "scrub_DVARS" object
Description
Summary method for class "scrub_DVARS"
Usage
## S3 method for class 'scrub_DVARS'
summary(object, ...)
## S3 method for class 'summary.scrub_DVARS'
print(x, ...)
## S3 method for class 'scrub_DVARS'
print(x, ...)
Arguments
| object | Object of class  | 
| ... | further arguments passed to or from other methods. | 
| x | Object of class  | 
Value
A plot of the scrubbing results
Summarize a "scrub_FD" object
Description
Summary method for class "scrub_FD"
Usage
## S3 method for class 'scrub_FD'
summary(object, ...)
## S3 method for class 'summary.scrub_FD'
print(x, ...)
## S3 method for class 'scrub_FD'
print(x, ...)
Arguments
| object | Object of class  | 
| ... | further arguments passed to or from other methods. | 
| x | Object of class  | 
Value
A plot of the scrubbing results
Summarize a "scrub_projection" object
Description
Summary method for class "scrub_projection"
Usage
## S3 method for class 'scrub_projection'
summary(object, ...)
## S3 method for class 'summary.scrub_projection'
print(x, ...)
## S3 method for class 'scrub_projection'
print(x, ...)
Arguments
| object | Object of class  | 
| ... | further arguments passed to or from other methods. | 
| x | Object of class  | 
Value
A plot of the scrubbing results