Movatterモバイル変換


[0]ホーム

URL:


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 PhamORCID iD [ctb], David Bolin [ctb], Yu (Ryan) Yue [ctb], Daniel SpencerORCID iD [aut], Sarah Ryan [ctb]
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"xifti" object from theciftiTools package. For multi-sessionanalysis this can be a vector of file paths or a list of"xifti"objects.

IfBOLD is a"xifti" object(s), the surfaces, if any, will beused for the spatial model. However, ifsurfL andsurfR areprovided, they will override any surfaces inBOLD.


Bayes GLM arg checks

Description

Checks arguments forBayesGLM andfit_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

SeeBayesGLM.

Bayes,EM

SeeBayesGLM.

ar_order,ar_smooth,aic

SeeBayesGLM.

n_threads

SeeBayesGLM.

return_INLA

SeeBayesGLM.

verbose

SeeBayesGLM.

meanTol,varTol,emTol

SeeBayesGLM.

Details

Avoids duplicated code betweenBayesGLM andfit_bayesglm

Value

The arguments that may have changed, in a list:scale_BOLD,do_Bayesian,do_EM, anddo_pw.


Connectome Workbench

Description

Connectome Workbench

Connectome Workbench Requirement

This function uses a system wrapper for the 'wb_command' executable. Theuser must first download and install the Connectome Workbench, availablefrom 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 thefirst 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

0 (default) for the HRF,1 for the first derivativeof the HRF, or2 for the second derivative of the HRF.

a1

delay of response. Default:6

b1

response dispersion. Default:0.9

a2

delay of undershoot. Default:12

b2

dispersion of undershoot. Default:0.9

c

scale of undershoot. Default:0.35

Value

HRF vector (or dHRF, or d2HRF) corresponding to time

Examples

upsample <- 100HRF96(seq(0, 30, by=1/upsample))

Canonical HRF and Derivatives

Description

Calculate the HRF from a time vector and parameters, or its derivative withrespect 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

0 (default) for the HRF,1 for the delay derivativeof the HRF, or2 for the dispersion derivative of the HRF.

a1

delay of response. Default:6

b1

response dispersion. Default:1

a2

delay of undershoot. Default:16/6 * a1 * sqrt(b1) = 16

b2

dispersion of undershoot. Default:b1 = 1

c

scale of undershoot. Default:1/6

o

onset of response. Default:0

Value

HRF vector (or dHRF, or d2HRF) corresponding to time vector t

Examples

samples_per_sec <- 200nsec <- 50HRF_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 thefirst or second derivative of the HRF instead. Form of HRF is similar to SPMbut here the response and undershoot are scaled so the difference of the HRFspeaks 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:6

b1

response dispersion. Default:1

a2

delay of undershoot. Default:16/6*a1 = 16

b2

dispersion of undershoot. Default:b1 = 1

c

scale of undershoot. Default:1/6

o

onset of response (in seconds). Default:0

Value

HRF vector corresponding to time vector t

Examples

upsample <- 100HRF_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) toselect AR model orders between0 andar_order? Default:FALSE.


ar_order

Description

ar_order

Arguments

ar_order

(For prewhitening) The order of the autoregressive (AR) modelto use for prewhitening. If0, do not prewhiten. Default:6.

For multi-session modeling, note that a single AR model is used; itscoefficients will be the average estimate from each session.


ar_smooth

Description

ar_smooth

Arguments

ar_smooth

(For prewhitening) The FWHM parameter for spatiallysmoothing the coefficient estimates for the AR model to use forprewhitening. Recall that\sigma = \frac{FWHM}{2*sqrt(2*log(2)}. Set to0 to not smooththe estimates. Default:5.


brainstructures

Description

brainstructures

Arguments

brainstructures

Character vector indicating which brain structure(s)ofBOLD to analyze:"left" cortex;"right" cortex;and/or"subcortical" structures. Or"all" to model all three.Default:c("left","right") (cortex only).


cbind if first argument might beNULL

Description

cbind, but return the second argument if the first isNULL

Usage

cbind2(mat_or_NULL, to_add)

Arguments

mat_or_NULL

NULL or a numeric matrix

to_add

A numeric matrix with the same number of rows asmat_or_NULL

Value

cbind(mat_or_NULL, to_add), or justto_add if the first argument is NULL.


Central derivative

Description

Take the central derivative of numeric vectors by averaging the forward andbackward differences.

Usage

cderiv(x)

Arguments

x

A numeric matrix, or a vector which will be converted to asingle-column matrix.

Value

A matrix or vector the same dimensions asx, with thederivative taken for each column ofx. The first and last rows mayneed 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 ordata.frame, or a"BayesfMRI_design" object frommake_design. Can alsobe an array where the third dimension is the same length as the number ofdata locations, to model each location with its own design.


Mask out invalid data

Description

Mask out data locations that are invalid (missing data, low mean, or lowvariance) for any session.

Usage

do_QC(BOLD, meanTol = 1e-06, varTol = 1e-06, verbose = TRUE)

Arguments

BOLD

A session-length list ofT \times V numeric BOLD data.

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:1e-6.

verbose

Print messages counting how many locations are removed?Default:TRUE.

Value

A logical vector indicating locations that are valid across all sessions.

Examples

nT <- 30nV <- 400BOLD1 <- matrix(rnorm(nT*nV), nrow=nT)BOLD1[,seq(30,50)] <- NABOLD2 <- matrix(rnorm(nT*nV), nrow=nT)BOLD2[,65] <- BOLD2[,65] / 1e10BOLD <- list(sess1=BOLD1, sess2=BOLD2)do_QC(BOLD)

faces

Description

faces

Arguments

faces

AnF \times 3 matrix, where each row contains the vertexindices for a given triangular face in the mesh.F is the number offaces in the mesh.


field_names

Description

field_names

Arguments

field_names

(Optional) Names of fields represented in design matrix.


Is this a valid entry inEVs?

Description

Is this valid data for a single task's EVs? Expects a data.frame ornumeric matrix with two numeric columns, EVs and durations, and at leastone row. Or, the valueNA 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 forBayesGLM,fit_bayesglm,multiGLM, andmultiGLM_fun.

Usage

format_design(  design,  scale_design = TRUE,  nS_expect = NULL,  nT_expect = NULL,  nD_expect = NULL,  per_location_design = NULL)

Arguments

design

Thedesign argument input. Will be formatted to anS-length list.

scale_design

Scale the design matrix by dividing each column by itsmaximum and then subtracting the mean? Default:TRUE. IfFALSE, the design matrix is centered but not scaled.

nS_expect

The expected number of sessions, if known.

nT_expect

The expected number of timepoints, if known. Formulti-session data this is a session-length vector.

nD_expect

The expected number of designs, if known. For per-locationmodeling this is equal tonVd0, the initial number of data locations.For multi-session data this is a session-length vector.

per_location_design

FALSE if per-location modeling is notbeing performed (i.e. for multiGLM);TRUE if it is; or,NULLto infer based on the dimensions ofdesign (TRUE if thedesign has three dimensions.)

Value

design


Format nuisance

Description

Format nuisance forBayesGLM,fit_bayesglm,multiGLM, andmultiGLM_fun.

Usage

format_nuisance(nuisance, nS_expect = NULL, nT_expect = NULL)

Arguments

nuisance

Thenuisance argument input. Will be formatted to anS-length list.

nS_expect

The expected number of sessions, if known.

nT_expect

The expected number of timepoints, if known. Formulti-session data this is a session-length vector.

Value

nuisance


Format scrub

Description

Format scrub forBayesGLM,fit_bayesglm,multiGLM, andmultiGLM_fun.

Usage

format_scrub(scrub, nS_expect = NULL, nT_expect = NULL)

Arguments

scrub

Thescrub argument input. Will be formatted to anS-length list.

nS_expect

The expected number of sessions, if known.

nT_expect

The expected number of timepoints, if known. Formulti-session data this is a session-length vector.

Value

scrub


hpf

Description

hpf

Arguments

hpf

Add DCT bases tonuisance to apply a temporal high-passfilter to the data, for detrending?hpf is the filter frequency.UseNULL to skip detrending. Detrending is strongly recommended forfMRI data, to help reduce the autocorrelation in the residuals, soNULL will induce a warning. Use"already" to disable thewarning while skipping highpass filtering.

Using at least two DCT bases is as sufficient for detrending as using linearand quadratic drift terms in the nuisance matrix. So if DCT detrending isbeing used here, there is no need to add linear and quadratic drift terms tonuisance.


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 eachentry represents a task as a matrix of onsets (first column) and durations(second column) for each stimuli (each row) of the task, in seconds. Listnames should be the task names.nTime andTR are required.

An example of a properly-formattedEVs is:on_s1 <- list(taskA=cbind(on=c(1,9,17), dr=rep(1,3)), taskB=cbind(on=c(3,27), dr=rep(5,2))).In this example, there are two tasks: the first has three 1s-long stimuli,while the second has two 5s-long stimuli.

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 to0 to only model the main HRF regressor (default), and not include itsderivatives; set to1 to model the temporal derivative too;or, set to2 to model both the temporal and dispersion derivatives.IfdHRF==0, there is one design column (field) per task. IfdHRF==1, there are two fields per task. And ifdHRF==2, thereare three fields per task.

If there are several tasks anddHRF>0, the total number of designmatrix columns may exceed five, which may require large computation timeswith INLA. The analysis can be adjusted by modeling the derivatives asnuisance signals rather than as fields. To do so, move the correspondingcolumns from the design matrix to thenuisance argument forBayesGLM.

upsample

Upsample factor for convolving stimulus boxcar or stickfunction with canonical HRF. Default:100.

onset,offset

Add task regressors indicating the onset and/or offset ofeach event block? Provide the names of the tasks as a character vector. Allonsets (or offsets) across the specified tasks will be represented by oneadditional column in the design matrix. The task names must match the namesofEVs. Can also be"all" to use all tasks.

Onsets/offset modeling is only compatible with a block design experiment.An error will be raised if the events inEVs do not have durationgreater than one second.

scale_design

Scale the columns of the design matrix? Default:TRUE.

onsets_sep,offsets_sep

Model the onsets (onsets_sep) or offsets(offsets_sep) separately for each task? Default:FALSE, tomodel all onsets together, or all offsets together, as a single field in thedesign.

verbose

Print diagnostic messages? Default:TRUE.

...

Additional arguments toHRF_calc.

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 inputdHRF parameter.

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 <- .72nTime <- ceiling(65/TR)make_design(EVs, nTime, TR)

mask: vertices

Description

mask: vertices

Arguments

mask

A lengthV logical vector indicating if each vertex iswithin the input mask.


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:1e-6 for both.


multiGLM for CIFTI

Description

Performs classical Bayesian GLM for task fMRI activation with CIFTI-formatdata, evaluating multiple design matrices. Includes the pre-processingsteps 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"xifti" object from theciftiTools package. For multi-sessionanalysis this can be a vector of file paths or a list of"xifti"objects.

IfBOLD is a"xifti" object(s), the surfaces, if any, will beused for the spatial model. However, ifsurfL andsurfR areprovided, they will override any surfaces inBOLD.

design

A 3D numeric array that is locations by fields by designs.

brainstructures

Character vector indicating which brain structure(s)ofBOLD to analyze:"left" cortex;"right" cortex;and/or"subcortical" structures. Or"all" to model all three.Default:c("left","right") (cortex only).

TR

Temporal resolution of the data, in seconds.

resamp_res

For cortex spatial model. The number of vertices to whicheach cortical surface should be resampled, orNULL to not resample.

For computational feasibility, a value of10000 (default) or lower isrecommended for Bayesian spatial modeling. IfBayes=FALSE,resamp_res can be set toNULL for full-resolution classicalmodeling.

hpf

Add DCT bases tonuisance to apply a temporal high-passfilter to the data, for detrending?hpf is the filter frequency.UseNULL to skip detrending. Detrending is strongly recommended forfMRI data, to help reduce the autocorrelation in the residuals, soNULL will induce a warning. Use"already" to disable thewarning while skipping highpass filtering.

Using at least two DCT bases is as sufficient for detrending as using linearand quadratic drift terms in the nuisance matrix. So if DCT detrending isbeing used here, there is no need to add linear and quadratic drift terms tonuisance.

nuisance

(Optional) AT \times N_{nuis} matrix of nuisance signals,whereT is the number of timepoints andN is the number ofnuisance signals, or a list of these for multi-session analysis. Nuisancesignals are regressed from the fMRI data and design matrix prior to GLMcomputation. Nuisance signals can include motion regressors, HRF derivativesnot being modeled as tasks, and other sources of noise.

Detrending/high-pass filtering is accomplished by adding DCT bases to thenuisance matrix; see the parametershpf andDCT.

Do not add spike regressors for scrubbing to thenuisance matrix.Rather, provide these inscrub so that their corresponding timepointsare also removed from the BOLD data after nuisance regression.

design_canonical

TO DO

verbose

1 (default) to print occasional updates during modelcomputation;2 for occasional updates as well as running INLA inverbose mode (ifBayes), or0 for no printed updates.

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:1e-6 for both.

Value

An object of class"mGLM": a list with elements

brainstructures

data.frame summarizing the spatial features of each brain structure modeled.

fields

data.frame with thename, relatedtask, andHRF_order of each field.

Connectome Workbench Requirement

This function uses a system wrapper for the 'wb_command' executable. Theuser must first download and install the Connectome Workbench, availablefrom 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

1 (default) to print occasional updates during modelcomputation;2 for occasional updates as well as running INLA inverbose mode (ifBayes), or0 for no printed updates.

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:1e-6 for mean and variance,50 for SNR.

Value

A list with elements

bestmodel

...

Fstat

...

pvalF

...


nuisance

Description

nuisance

Arguments

nuisance

(Optional) AT \times N_{nuis} matrix of nuisance signals,whereT is the number of timepoints andN is the number ofnuisance signals, or a list of these for multi-session analysis. Nuisancesignals are regressed from the fMRI data and design matrix prior to GLMcomputation. Nuisance signals can include motion regressors, HRF derivativesnot being modeled as tasks, and other sources of noise.

Detrending/high-pass filtering is accomplished by adding DCT bases to thenuisance matrix; see the parametershpf andDCT.

Do not add spike regressors for scrubbing to thenuisance matrix.Rather, provide these inscrub so that their corresponding timepointsare also removed from the BOLD data after nuisance regression.


S3 method: useview_xifti to plot a"BGLM" object

Description

S3 method: useview_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 toplot_design.

Value

Result of the call toplot_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

"lineplot" (default) or"imageplot".

...

Additional arguments toplot_design_line orplot_design_image.

colors

The name of a ColorBrewer palette (seeRColorBrewer::brewer.pal.info and colorbrewer2.org), the name of aviridisLite palette, or a character vector of colors. Default:"Set1".

linetype,linewidth,alpha

Parameters forggplot2::geom_line.Defaults:"solid" linetype,0.7 linewidth and0.8alpha.linetype can also be a vector of options with length matchingthe number of fields indesign.

Value

A ggplot

A ggplot

A ggplot


resamp_res

Description

resamp_res

Arguments

resamp_res

For cortex spatial model. The number of vertices to whicheach cortical surface should be resampled, orNULL to not resample.

For computational feasibility, a value of10000 (default) or lower isrecommended for Bayesian spatial modeling. IfBayes=FALSE,resamp_res can be set toNULL for full-resolution classicalmodeling.


scale_BOLD

Description

scale_BOLD

Arguments

scale_BOLD

Controls scaling the BOLD response at each location.

"mean":

Scale the data to percent local signal change.

"sd":

Scale the data by local standard deviation.

"none":

Center the data but do not scale it.


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, whereT 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) AT \times N_{scrub} matrix of spike regressors(one 1 value at the timepoint to scrub, and 0 for all other values), or alogical vector indicating the timepoints to scrub (TRUE to scrub, andFALSE to keep). For multi-session data, a session-length list ofsuch matrices or logical vectors.

The spike regressors will be included in the nuisanceregression, and afterwards the timepoints indicated inscrub will beremoved from the BOLD data and design matrix.


session_names

Description

session_names

Arguments

session_names

The names of the task-fMRIBOLD sessions, formulti-session analysis. If not provided here, will be inferred fromnames(BOLD), inferred fromnames(design), or generatedautomatically, in that order.


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"BfMRI_design".

...

further arguments passed to or from other methods.

x

Object of class"summary.BfMRI_design".

Value

A"summary.BfMRI_design" object, a list summarizing theproperties ofobject.

NULL, invisibly.

NULL, invisibly.


surfaces

Description

surfaces

Arguments

surfL,surfR

For cortex spatial model. Left and right cortex surfacegeometry in GIFTI format ("*.surf.gii"). These can be a file path toa GIFTI file or a"surf" object fromciftiTools.

Surfaces can alternatively be provided through the$surf metadata inBOLD if it is"xifti" data. If neither are provided, by default theHCP group-average fs_LR inflated surfaces included inciftiTools will beused for the cortex spatial model.


verbose

Description

verbose

Arguments

verbose

1 (default) to print occasional updates during modelcomputation;2 for occasional updates as well as running INLA inverbose mode (ifBayes), or0 for no printed updates.


[8]ページ先頭

©2009-2025 Movatter.jp