| Type: | Package | 
| Title: | Hemodynamic Response Function | 
| Version: | 0.1.3 | 
| Maintainer: | Amanda Mejia <mandy.mejia@gmail.com> | 
| Description: | Computes the hemodynamic response function (HRF) for task functional magnetic resonance imaging (fMRI) data. Also includes functions for constructing a design matrix from task fMRI event timings, and for comparing multiple design matrices in a general linear model (GLM). A wrapper function is provided for GLM analysis of CIFTI-format data. Lastly, there are supporting functions which provide visual summaries of the HRFs and design matrices. | 
| License: | GPL-3 | 
| URL: | https://github.com/mandymejia/hrf | 
| BugReports: | https://github.com/mandymejia/hrf/issues | 
| Depends: | R (≥ 3.6.0) | 
| Imports: | car, ciftiTools (≥ 0.15.0), fMRItools, Matrix, matrixStats, stats | 
| Suggests: | covr, ggplot2, knitr, rmarkdown, testthat (≥ 3.0.0), tidyr, spelling | 
| VignetteBuilder: | knitr | 
| Encoding: | UTF-8 | 
| RoxygenNote: | 7.3.2 | 
| Language: | en-US | 
| NeedsCompilation: | no | 
| Packaged: | 2025-01-29 20:47:30 UTC; ddpham | 
| Author: | Amanda Mejia [aut, cre],
  Damon Pham | 
| Repository: | CRAN | 
| Date/Publication: | 2025-01-30 19:10:02 UTC | 
BOLD
Description
BOLD
Arguments
| BOLD | fMRI timeseries data in CIFTI format ("*.dtseries.nii").
For single-session analysis this can be a file path to a CIFTI file or a
 If  | 
Bayes GLM arg checks
Description
Checks arguments for BayesGLM and fit_bayesglm
Usage
BayesGLM_argChecks(
  scale_BOLD = c("mean", "sd", "none"),
  Bayes = TRUE,
  EM = FALSE,
  ar_order = 6,
  ar_smooth = 5,
  aic = FALSE,
  n_threads = 4,
  return_INLA = c("trimmed", "full", "minimal"),
  verbose = 1,
  meanTol = 1e-06,
  varTol = 1e-06,
  emTol = 0.001
)
Arguments
| scale_BOLD | See  | 
| Bayes,EM | See  | 
| ar_order,ar_smooth,aic | See  | 
| n_threads | See  | 
| return_INLA | See  | 
| verbose | See  | 
| meanTol,varTol,emTol | See  | 
Details
Avoids duplicated code between BayesGLM and fit_bayesglm
Value
The arguments that may have changed, in a list: scale_BOLD,
do_Bayesian, do_EM, and do_pw.
Connectome Workbench
Description
Connectome Workbench
Connectome Workbench Requirement
This function uses a system wrapper for the 'wb_command' executable. The user must first download and install the Connectome Workbench, available from https://www.humanconnectome.org/software/get-connectome-workbench .
GLM multi
Description
GLM multi
Usage
GLM_multi(y, X, X2, Xc = NULL, verbose = TRUE)
Arguments
| y,X,X2 | BOLD, design, nuisance | 
| Xc | (Optional) canonical design matrix | 
| verbose | verbose? | 
Value
Results for GLM multi
Canonical (double-gamma) HRF (old one from SPM96, Glover)
Description
Calculate the HRF from a time vector and parameters. Optionally compute the first or second derivative of the HRF instead.
Usage
HRF96(t, deriv = 0, a1 = 6, b1 = 0.9, a2 = 12, b2 = 0.9, c = 0.35)
Arguments
| t | time vector | 
| deriv | 
 | 
| a1 | delay of response. Default:  | 
| b1 | response dispersion. Default:  | 
| a2 | delay of undershoot. Default:  | 
| b2 | dispersion of undershoot. Default:  | 
| c | scale of undershoot. Default:  | 
Value
HRF vector (or dHRF, or d2HRF) corresponding to time
Examples
upsample <- 100
HRF96(seq(0, 30, by=1/upsample))
Canonical HRF and Derivatives
Description
Calculate the HRF from a time vector and parameters, or its derivative with respect to delay or dispersion.
Usage
HRF_calc(
  t,
  deriv = 0,
  a1 = 6,
  b1 = 1,
  a2 = 16/6 * a1 * sqrt(b1),
  b2 = b1,
  c = 1/6,
  o = 0
)
Arguments
| t | time vector (in units of seconds) | 
| deriv | 
 | 
| a1 | delay of response. Default:  | 
| b1 | response dispersion. Default:  | 
| a2 | delay of undershoot. Default:  | 
| b2 | dispersion of undershoot. Default:  | 
| c | scale of undershoot. Default:  | 
| o | onset of response. Default:  | 
Value
HRF vector (or dHRF, or d2HRF) corresponding to time vector t
Examples
samples_per_sec <- 200
nsec <- 50
HRF_calc(seq(nsec*samples_per_sec)/samples_per_sec)
Canonical (double-gamma) HRF
Description
Calculate the HRF from a time vector and parameters. Optionally compute the first or second derivative of the HRF instead. Form of HRF is similar to SPM but here the response and undershoot are scaled so the difference of the HRFs peaks at 1 and -c
Usage
HRF_main(t, a1 = 6, b1 = 1, a2 = NULL, b2 = NULL, c = 1/6, o = 0)
Arguments
| t | time vector (in seconds). Must be equally spaced. | 
| a1 | delay of response. Default:  | 
| b1 | response dispersion. Default:  | 
| a2 | delay of undershoot. Default:  | 
| b2 | dispersion of undershoot. Default:  | 
| c | scale of undershoot. Default:  | 
| o | onset of response (in seconds). Default:  | 
Value
HRF vector corresponding to time vector t
Examples
upsample <- 100
HRF_main(seq(0, 30, by=1/upsample))
TR
Description
TR
Arguments
| TR | Temporal resolution of the data, in seconds. | 
aic
Description
aic
Arguments
| aic | (For prewhitening) Use the Akaike information criterion (AIC) to
select AR model orders between  | 
ar_order
Description
ar_order
Arguments
| ar_order | (For prewhitening) The order of the autoregressive (AR) model
to use for prewhitening. If  For multi-session modeling, note that a single AR model is used; its coefficients will be the average estimate from each session. | 
ar_smooth
Description
ar_smooth
Arguments
| ar_smooth | (For prewhitening) The FWHM parameter for spatially
smoothing the coefficient estimates for the AR model to use for
prewhitening. Recall that
 | 
brainstructures
Description
brainstructures
Arguments
| brainstructures | Character vector indicating which brain structure(s)
of  | 
cbind if first argument might be NULL
Description
cbind, but return the second argument if the first is NULL
Usage
cbind2(mat_or_NULL, to_add)
Arguments
| mat_or_NULL | 
 | 
| to_add | A numeric matrix with the same number of rows as  | 
Value
cbind(mat_or_NULL, to_add), or just to_add if the first argument is NULL.
Central derivative
Description
Take the central derivative of numeric vectors by averaging the forward and backward differences.
Usage
cderiv(x)
Arguments
| x | A numeric matrix, or a vector which will be converted to a single-column matrix. | 
Value
A matrix or vector the same dimensions as x, with the
derivative taken for each column of x. The first and last rows may
need to be deleted, depending on the application.
Examples
x <- cderiv(seq(5))
stopifnot(all(x == c(.5, 1, 1, 1, .5)))
design
Description
design
Arguments
| design | A numeric matrix or  | 
Mask out invalid data
Description
Mask out data locations that are invalid (missing data, low mean, or low variance) for any session.
Usage
do_QC(BOLD, meanTol = 1e-06, varTol = 1e-06, verbose = TRUE)
Arguments
| BOLD | A session-length list of  | 
| meanTol,varTol | Tolerance for mean and variance of each data location.
Locations which do not meet these thresholds are masked out of the analysis.
Defaults:  | 
| verbose | Print messages counting how many locations are removed?
Default:  | 
Value
A logical vector indicating locations that are valid across all sessions.
Examples
nT <- 30
nV <- 400
BOLD1 <- matrix(rnorm(nT*nV), nrow=nT)
BOLD1[,seq(30,50)] <- NA
BOLD2 <- matrix(rnorm(nT*nV), nrow=nT)
BOLD2[,65] <- BOLD2[,65] / 1e10
BOLD <- list(sess1=BOLD1, sess2=BOLD2)
do_QC(BOLD)
faces
Description
faces
Arguments
| faces | An  | 
field_names
Description
field_names
Arguments
| field_names | (Optional) Names of fields represented in design matrix. | 
Is this a valid entry in EVs?
Description
Is this valid data for a single task's EVs? Expects a data.frame or
numeric matrix with two numeric columns, EVs and durations, and at least
one row. Or, the value NA for an empty task.
Usage
format_EV(EV)
Arguments
| EV | The putative EVs matrix or data frame | 
Value
Length-one logical vector.
Format design
Description
Format design for BayesGLM, fit_bayesglm,
multiGLM, and multiGLM_fun.
Usage
format_design(
  design,
  scale_design = TRUE,
  nS_expect = NULL,
  nT_expect = NULL,
  nD_expect = NULL,
  per_location_design = NULL
)
Arguments
| design | The  | 
| scale_design | Scale the design matrix by dividing each column by its
maximum and then subtracting the mean? Default:  | 
| nS_expect | The expected number of sessions, if known. | 
| nT_expect | The expected number of timepoints, if known. For multi-session data this is a session-length vector. | 
| nD_expect | The expected number of designs, if known. For per-location
modeling this is equal to  | 
| per_location_design | 
 | 
Value
design
Format nuisance
Description
Format nuisance for BayesGLM, fit_bayesglm,
multiGLM, and multiGLM_fun.
Usage
format_nuisance(nuisance, nS_expect = NULL, nT_expect = NULL)
Arguments
| nuisance | The  | 
| nS_expect | The expected number of sessions, if known. | 
| nT_expect | The expected number of timepoints, if known. For multi-session data this is a session-length vector. | 
Value
nuisance
Format scrub
Description
Format scrub for BayesGLM, fit_bayesglm,
multiGLM, and multiGLM_fun.
Usage
format_scrub(scrub, nS_expect = NULL, nT_expect = NULL)
Arguments
| scrub | The  | 
| nS_expect | The expected number of sessions, if known. | 
| nT_expect | The expected number of timepoints, if known. For multi-session data this is a session-length vector. | 
Value
scrub
hpf
Description
hpf
Arguments
| hpf | Add DCT bases to  Using at least two DCT bases is as sufficient for detrending as using linear
and quadratic drift terms in the nuisance matrix. So if DCT detrending is
being used here, there is no need to add linear and quadratic drift terms to
 | 
Is a matrix or data.frame?
Description
Is this a matrix or data.frame?
Usage
is_matrix_or_df(x)
Arguments
| x | The object | 
Value
Length-one logical.
Is a valid design?
Description
Is a valid design?
Usage
is_valid_one_design(design)
Arguments
| design | The design matrix/array | 
Is a valid nuisance?
Description
Is a valid nuisance?
Usage
is_valid_one_nuisance(nuisance)
Arguments
| nuisance | The nuisance matrix | 
Is a valid scrub?
Description
Is a valid scrub?
Usage
is_valid_one_scrub(scrub)
Arguments
| scrub | The scrub matrix | 
Make design matrix
Description
Make the design matrix for the GLM, from the task information.
Usage
make_design(
  EVs,
  nTime,
  TR,
  dHRF = 0,
  upsample = 100,
  onset = NULL,
  offset = NULL,
  scale_design = TRUE,
  onsets_sep = FALSE,
  offsets_sep = FALSE,
  verbose = TRUE,
  ...
)
Arguments
| EVs | The explanatory variables i.e. the task stimulus information,
from which a design matrix will be constructed. This is a list where each
entry represents a task as a matrix of onsets (first column) and durations
(second column) for each stimuli (each row) of the task, in seconds. List
names should be the task names.  An example of a properly-formatted  | 
| nTime | the number of timepoints (volumes) in the task fMRI data. | 
| TR | the temporal resolution of the data, in seconds. | 
| dHRF | Controls the extent of HRF derivatives modeling. Set to  If there are several tasks and  | 
| upsample | Upsample factor for convolving stimulus boxcar or stick
function with canonical HRF. Default:  | 
| onset,offset | Add task regressors indicating the onset and/or offset of
each event block? Provide the names of the tasks as a character vector. All
onsets (or offsets) across the specified tasks will be represented by one
additional column in the design matrix. The task names must match the names
of  Onsets/offset modeling is only compatible with a block design experiment.
An error will be raised if the events in  | 
| scale_design | Scale the columns of the design matrix? Default:
 | 
| onsets_sep,offsets_sep | Model the onsets ( | 
| verbose | Print diagnostic messages? Default:  | 
| ... | Additional arguments to  | 
Value
A "BfMRI_design" object: a list with elements
- design
- The volumes by fields design matrix. Column names are field names. 
- field_names
- The name of each task from the provided onsets. 
- dHRF
- The input - dHRFparameter.
- HRF_info
- Additional HRF modeling results. 
Examples
EVs <- list(taskA=cbind(on=c(1,9,17), dr=rep(1,3)), taskB=cbind(on=c(3,27), dr=rep(5,2)))
TR <- .72
nTime <- ceiling(65/TR)
make_design(EVs, nTime, TR)
mask: vertices
Description
mask: vertices
Arguments
| mask | A length  | 
mean and variance tolerance
Description
mean and variance tolerance
Arguments
| meanTol,varTol | Tolerance for mean and variance of each data location.
Locations which do not meet these thresholds are masked out of the analysis.
Default:  | 
multiGLM for CIFTI
Description
Performs classical Bayesian GLM for task fMRI activation with CIFTI-format data, evaluating multiple design matrices. Includes the pre-processing steps of nuisance regression. Supports single-session analysis only.
Usage
multiGLM(
  BOLD,
  design,
  brainstructures = c("left", "right"),
  TR = NULL,
  resamp_res = 10000,
  hpf = NULL,
  nuisance = NULL,
  design_canonical = NULL,
  verbose = 1,
  meanTol = 1e-06,
  varTol = 1e-06
)
Arguments
| BOLD | fMRI timeseries data in CIFTI format ("*.dtseries.nii").
For single-session analysis this can be a file path to a CIFTI file or a
 If  | 
| design | A 3D numeric array that is locations by fields by designs. | 
| brainstructures | Character vector indicating which brain structure(s)
of  | 
| TR | Temporal resolution of the data, in seconds. | 
| resamp_res | For cortex spatial model. The number of vertices to which
each cortical surface should be resampled, or  For computational feasibility, a value of  | 
| hpf | Add DCT bases to  Using at least two DCT bases is as sufficient for detrending as using linear
and quadratic drift terms in the nuisance matrix. So if DCT detrending is
being used here, there is no need to add linear and quadratic drift terms to
 | 
| nuisance | (Optional) A  Detrending/high-pass filtering is accomplished by adding DCT bases to the
nuisance matrix; see the parameters  Do not add spike regressors for scrubbing to the  | 
| design_canonical | TO DO | 
| verbose | 
 | 
| meanTol,varTol | Tolerance for mean and variance of each data location.
Locations which do not meet these thresholds are masked out of the analysis.
Default:  | 
Value
An object of class "mGLM": a list with elements
- brainstructures
- data.framesummarizing the spatial features of each brain structure modeled.
- fields
- data.framewith the- name, related- task, and- HRF_orderof each field.
Connectome Workbench Requirement
This function uses a system wrapper for the 'wb_command' executable. The user must first download and install the Connectome Workbench, available from https://www.humanconnectome.org/software/get-connectome-workbench .
multiGLM0
Description
Performs classical GLM for task fMRI activation, comparing multiple designs
Usage
multiGLM_fun(
  BOLD,
  design,
  nuisance = NULL,
  design_canonical = NULL,
  verbose = 1,
  meanTol = 1e-06,
  varTol = 1e-06
)
Arguments
| BOLD,design,nuisance | Session-length list of numeric matrices/arrays, each with volumes along the first dimension. | 
| design_canonical | TO DO | 
| verbose | 
 | 
| meanTol,varTol | Tolerance for mean, variance and SNR of each data location.
Locations which do not meet these thresholds are masked out of the analysis.
Default:  | 
Value
A list with elements
- bestmodel
- ... 
- Fstat
- ... 
- pvalF
- ... 
nuisance
Description
nuisance
Arguments
| nuisance | (Optional) A  Detrending/high-pass filtering is accomplished by adding DCT bases to the
nuisance matrix; see the parameters  Do not add spike regressors for scrubbing to the  | 
S3 method: use view_xifti to plot a "BGLM" object
Description
S3 method: use view_xifti to plot a "BGLM" object
Usage
## S3 method for class 'BfMRI_design'
plot(x, ...)
Arguments
| x | An object of class "BfMRI_design". | 
| ... | Additional arguments to  | 
Value
Result of the call to plot_design
Plot design matrix
Description
Plot design matrix
Plot design with lineplot
Plot design with imageplot
Usage
plot_design(design, method = c("lineplot", "imageplot"), ...)
plot_design_line(
  design,
  colors = "Set1",
  linetype = "solid",
  linewidth = 0.7,
  alpha = 0.8
)
plot_design_image(design)
Arguments
| design | The timepoints by fields design matrix or data.frame. | 
| method | 
 | 
| ... | Additional arguments to  | 
| colors | The name of a ColorBrewer palette (see
RColorBrewer::brewer.pal.info and colorbrewer2.org), the name of a
viridisLite palette, or a character vector of colors. Default:
 | 
| linetype,linewidth,alpha | Parameters for  | 
Value
A ggplot
A ggplot
A ggplot
resamp_res
Description
resamp_res
Arguments
| resamp_res | For cortex spatial model. The number of vertices to which
each cortical surface should be resampled, or  For computational feasibility, a value of  | 
scale_BOLD
Description
scale_BOLD
Arguments
| scale_BOLD | Controls scaling the BOLD response at each location. 
 | 
Scale the design matrix
Description
Scale the design matrix
Usage
scale_design_mat(design_mat)
Arguments
| design_mat | The original (unscaled) design matrix that is T x K, where T is the number of time points, and k is the number of field covariates | 
Value
A scaled design matrix
scrub
Description
scrub
Arguments
| scrub | (Optional) A  The spike regressors will be included in the nuisance
regression, and afterwards the timepoints indicated in  | 
session_names
Description
session_names
Arguments
| session_names | The names of the task-fMRI  | 
Summarize a "BfMRI_design" object
Description
Summary method for class "BfMRI_design"
Usage
## S3 method for class 'BfMRI_design'
summary(object, ...)
## S3 method for class 'summary.BfMRI_design'
print(x, ...)
## S3 method for class 'BfMRI_design'
print(x, ...)
Arguments
| object | Object of class  | 
| ... | further arguments passed to or from other methods. | 
| x | Object of class  | 
Value
A "summary.BfMRI_design" object, a list summarizing the
properties of object.
NULL, invisibly.
NULL, invisibly.
surfaces
Description
surfaces
Arguments
| surfL,surfR | For cortex spatial model. Left and right cortex surface
geometry in GIFTI format ("*.surf.gii"). These can be a file path to
a GIFTI file or a  Surfaces can alternatively be provided through the  | 
verbose
Description
verbose
Arguments
| verbose | 
 |