Nothing
      ###############################################################################
##                             ReacNorm R package                            ##
##             Functions to compute V_plas and related parameters            ##
##       ----------------------------------------------------------------    ##
##                           Pierre de Villemereuil                          ##
##       ----------------------------------------------------------------    ##
##                                     2024                                  ##
###############################################################################
## --------------------------------------------------------------- LICENCE ----
#    This program is free software: you can redistribute it and/or modify
#    it under the terms of the GNU General Public License as published by
#    the Free Software Foundation, either version 3 of the License, or
#    (at your option) any later version.
#
#    This program is distributed in the hope that it will be useful,
#    but WITHOUT ANY WARRANTY; without even the implied warranty of
#    MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the
#    GNU General Public License for more details.
#
#    You should have received a copy of the GNU General Public License
#    along with this program.  If not, see <http://www.gnu.org/licenses/>.
##  ---------------------------------------------------- Backend functions ----
## Compute the average phenotype conditional to the environment
# Args: - e: the environmental value to condition to
#       - func: the function of the reaction norm fitted by the model
#       - theta: the average parameters estimated by the model
#       - V_theta: the genetic variance-covariance matrix estimated by the model
#       - fixed: which part of the parameters are fixed (no genetic variation)
#       - width: the width over which the integral must be computed
#                (10 is a generally a good value)
# Value: The value for E_g_e (numeric)
rn_avg_e <- function(e,
                     func,
                     theta,
                     V_theta,
                     fixed = NULL,
                     width = 10) {
    # Handling when some terms are fixed
    if (!is.null(fixed)) {
        var       <- setdiff(1:length(theta), fixed)
        full_theta <- theta
        var_theta  <- theta[-fixed]
        if (nrow(V_theta) == length(theta)) {
            V_theta <- V_theta[-fixed, -fixed]
        }
    } else {
        full_theta <- theta
        var_theta  <- theta
    }
    # Setting the integral width according to vcov (lower mean-w, upper mean+w)
    w <- sqrt(diag(V_theta)) * width
    # Number of dimensions
    d <- length(w)
    # Computing the logdet of vcov
    logdet <- calc_logdet(V_theta)
    # Average
    avg <- cubature::hcubature(
        f  = function(x) {
            full_x <- matrix(full_theta, nrow = length(full_theta), ncol = ncol(x))
            if (!is.null(fixed)) { full_x[var, ] <- x } else { full_x <- x }
            func(e, full_x) * vec_mvnorm(x, var_theta, V_theta, logdet)
        },
        lowerLimit      = var_theta - w,
        upperLimit      = var_theta + w,
        fDim            = 1,
        tol             = 0.001,
        absError        = 0.0001,
        vectorInterface = TRUE
    )$integral
    return(avg)
}
##  --------------------------------------------------- Frontend functions ----
## Compute the mean phenotype by environment
# Args: - env: the environmental values over which the model has been estimated
#       - shape: the function of the reaction norm fitted by the model (must be named)
#       - theta: the average parameters estimated by the model
#       - V_theta: the genetic variance-covariance matrix estimated by the model
#       - fixed: which part of the parameters are fixed (no genetic variation)
#       - width: the width over which the integral must be computed
#                (10 is a generally a good value)
# Value: The value for V_plas (numeric)
rn_mean_by_env <- function(theta,
                           V_theta,
                           env,
                           shape,
                           fixed = NULL,
                           width = 10) {
    if (is.null(names(theta))) {
        stop("The vector theta must be named with the corresponding parameter names")
    }
    # Formatting the function of the shape for the computation of the integral
    func <- rn_generate_shape(shape, names(theta))
    sapply(env,
           \(e) rn_avg_e(e       = e,
                         func    = func,
                         theta   = theta,
                         V_theta = V_theta,
                         fixed   = fixed,
                         width   = width))
}
## Compute the plastic variance (V_plas)
# Args: - theta: the average parameters estimated by the model (must be named)
#       - V_theta: the G matrix containing the genetic variance-covariances of
#                  the parameters
#       - env: the environmental values over which the model has been estimated
#       - shape: the function of the reaction norm fitted by the model
#       - X: the design matrix if the model used was linear (incompatible with "shape")
#       - S: the error variance-covariance matrix of the linear model if X is used
#       - fixed: which part of the parameters are fixed (no genetic variation)
#       - wt_env: weights to use for computing the average over env
#                 (must be the same length as env)
#       - correction: should the Bessel correction be used or not?
#       - width: the width over which the integral must be computed
#                (10 is a generally a good value)
# Value: The value for V_plas (numeric)
rn_vplas <- function(theta,
                     V_theta = NULL,
                     env = NULL,
                     shape = NULL,
                     X = NULL,
                     S = NULL,
                     fixed = NULL,
                     wt_env = NULL,
                     correction = FALSE,
                     width = 10) {
    # theta must be named to know the names of parameters to format the "shape"
    if (is.null(names(theta))) {
        stop("The vector theta must be named with the corresponding parameter names")
    }
    # X is incompatible with shape
    if (is.null(X) & (is.null(shape) & is.null(env))) {
        stop("Either the shape and environment or the design matrix X of a reaction norm should be provided")
    } else if (!is.null(X) & !(is.null(shape) & is.null(env))) {
        stop("The arguments X and shape cannot be used together.\n If the design matrix is available, it is usually better to use the argument X.")
    }
    if (!is.null(X)) {
        # Check X and theta compatibility
        if (ncol(X) != length(theta)) {
            stop("The number of columns in X should be equal to the length of theta.")
        }
        # If X is used, it's better to provide S
        if (is.null(S)) {
            warning("It is important to provide the error variance-covariance matrix S when using X.")
            S <- matrix(0, ncol = ncol(X), nrow = ncol(X))
        }
    }
    # G is needed if X is not used
    if (is.null(V_theta) & is.null(X)) {
        stop("V_theta is needed if the non-linear approach (using env and shape) is used")
    }
    # Configure variance function
    method <- ifelse(correction, "unbiased", "ML")
    if (is.null(wt_env) & !is.null(env)) {
        wt_env <- rep(1/length(env), length(env))
    } else if (!is.null(X)) {
        wt_env <- rep(1/nrow(X), nrow(X))
    }
    func_var <- function(x) {
        cov.wt(cbind(x), wt = wt_env, method = method)[["cov"]]
    }
    # Compute V_Plas
    if (!is.null(X)) {
        # Compute the variance-covariance matrix of X
        cov_X <- func_var(X)
        # Compute the correcting factor due to the uncertainty
        var_uncert <- sum(cov_X * S)
        # Compute V_Plas
        out <- as.vector(t(theta) %*% cov_X %*% theta - var_uncert)
    } else {
        # Compute the average for each environment, then take the variance
        out <-
            rn_mean_by_env(theta    = theta,
                           V_theta  = V_theta,
                           env      = env,
                           shape    = shape,
                           fixed    = fixed,
                           width    = width) |>
            func_var() |>
            as.numeric()
    }
    return(out)
}
## Compute the pi-decomposition of V_Plas
# Args: - theta: the average parameters estimated by the model (must be named)
#       - V_theta: the G matrix containing the genetic variance-covariances of
#                  the parameters
#       - env: the environmental values over which the model has been estimated
#       - shape: the function of the reaction norm fitted by the model
#       - X: the design matrix if the model used was linear (incompatible with "shape")
#       - S: the error variance-covariance matrix of the linear model if X is used
#       - fixed: which part of the parameters are fixed (no genetic variation)
#       - wt_env: weights to use for computing the average over env
#                 (must be the same length as env)
#       - correction: should the Bessel correction be used or not?
#       - width: the width over which the integral must be computed
#                (10 is a generally a good value)
# Value: A data.frame containing V_Plas and the pi-decomposition
rn_pi_decomp <- function(theta,
                         V_theta,
                         env,
                         shape,
                         fixed = NULL,
                         wt_env = NULL,
                         correction = FALSE,
                         width = 10) {
    # theta must be named to know the names of parameters to format the "shape"
    if (is.null(names(theta))) {
        stop("The vector theta must be named with the corresponding parameter names")
    }
    # Use weighted mean if wt_env is not NULL
    if (is.null(wt_env)) {
        func_mean    <- mean
    } else {
        func_mean    <- function(x) { weighted.mean(x, w = wt_env) }
    }
    # Configure variance function
    method <- ifelse(correction, "unbiased", "ML")
    if (is.null(wt_env)) { wt_env <- rep(1/length(env), length(env)) }
    func_var <- function(x) {
        cov.wt(cbind(x), wt = wt_env, method = method)[["cov"]] |>
            as.numeric()
    }
    # Compute V_plas
    v_plas <-
        rn_vplas(theta      = theta,
                 V_theta    = V_theta,
                 env        = env,
                 shape      = shape,
                 fixed      = fixed,
                 wt_env     = wt_env,
                 correction = correction,
                 width      = width)
    # Compute the average slope
    d_func <- rn_generate_gradient(shape, "x", names(theta))
    mean_sl <-
        sapply(env,
               \(e) rn_avg_e(e       = e,
                             func    = d_func,
                             theta   = theta,
                             V_theta = V_theta,
                             fixed   = fixed,
                             width   = width)) |>
        func_mean()
    # Compute the variance due to the average slope
    var_sl <- (mean_sl)^2 * func_var(env)
    # Compute the average curvature
    d2_func <- rn_generate_2diff(shape, "x", names(theta))
    mean_cv <-
        sapply(env,
               \(e) rn_avg_e(e       = e,
                             func    = d2_func,
                             theta   = theta,
                             V_theta = V_theta,
                             fixed   = fixed,
                             width   = width)) |>
        func_mean()
    # Compute the variance due to the average curvature*
    var_cv <- 0.25 * (mean_cv)^2 * func_var(env^2)
    # Return the decomposition
    data.frame(V_Plas = v_plas,
               Pi_Sl  = var_sl / v_plas,
               Pi_Cv  = var_cv / v_plas)
}
## Compute the phi-decomposition of V_Plas
# Args: - theta: the average parameters estimated by the model (must be named)
#       - X: the design matrix containing the environmental values for each power
#            of the environment
#       - S: the error variance-covariance matrix of the estimates parameters of the linear model
#       - wt_env: weights to use for computing the average over env
#                 (must be the same length as env)
#       - correction: should the Bessel correction be used or not?
#       - v_plas: optionnaly, provide the value for v_plas if already computed
# Value: A data.frame containing V_Plas and the pi-decomposition
rn_phi_decomp <- function(theta,
                          X,
                          S = NULL,
                          wt_env = NULL,
                          correction = FALSE,
                          v_plas = NA) {
    # If X is used, it's better to provide S
    if (!is.null(X) & is.null(S)) {
        warning("It is important to provide the error variance-covariance matrix S when using X.")
        S <- matrix(0, ncol = ncol(X), nrow = ncol(X))
    }
    #  Checking that dimensions are correct
    if (ncol (X) != nrow(S) | ncol(X) != ncol(S)) {
        stop("Incompatible dimensions between the design matrix X and the error matrix S")
    }
    # Configure variance function
    method <- ifelse(correction, "unbiased", "ML")
    if (is.null(wt_env)) { wt_env <- rep(1/nrow(X), nrow(X)) }
    func_var <- function(x) {
        cov.wt(cbind(x), wt = wt_env, method = method)[["cov"]]
    }
    # Compute the variance-covariance matrix of X
    cov_X <- func_var(X)
    provided_v_plas <- ifelse(is.na(v_plas), FALSE, TRUE)
    # Compute the correcting factor due to the uncertainty
    var_uncert <- sum(cov_X * S)
    # Compute V_Plas from the linear model
    if (!provided_v_plas) {
        v_plas <- as.vector(t(theta) %*% cov_X %*% theta - var_uncert)
    } else {
        poly_v_plas <- as.vector(t(theta) %*% cov_X %*% theta - var_uncert)
    }
    names(v_plas) <- "V_Plas"
    # Computing the variance-linked components of the phi-decomposition
    phi_i <- diag(cov_X) * theta^2 - diag(cov_X * S)
    if (round(phi_i[1], digits = 10) != 0) {
        warning("The intercept-level phi_0 was not 0, did you include the intercept in the design matrix X?")
        intercept <- FALSE
    } else {
        # Removing the intercept-level phi_0
        phi_i <- phi_i[-1]
        intercept <- TRUE
    }
    if (!is.null(names(theta))) {
        if (intercept) {
            names <- names(theta)[-1]
        } else {
            names <- names(theta)
        }
    } else {
        start <- ifelse(intercept, 1, 0)
        end   <- ifelse(intercept, length(phi_i), length(phi_i) - 1)
        names <- seq(start, end)
    }
    names(phi_i) <- paste0("Phi_", names)
    # Computing the covariance-linked components of the phi-decomposition
    if (intercept) {
        cov_X_trim <- cov_X[-1, -1]
        S_trim     <- S[-1, -1]
        M_ij <- matrix(paste(rep(names, length(phi_i)),
                             rep(names, each = length(phi_i)),
                             sep = "_"),
                       ncol = length(phi_i), nrow = length(phi_i))
    } else {
        cov_X_trim <- cov_X
        S_trim     <- S
        M_ij <- matrix(paste(rep(names, length(phi_i)),
                             rep(names, each = length(phi_i)),
                             sep = "_"),
                       ncol = length(phi_i), nrow = length(phi_i))
    }
    phi_ij <- 2 * cov_X_trim[upper.tri(cov_X_trim)] -
              cov_X_trim[upper.tri(cov_X_trim)] * S_trim[upper.tri(S_trim)]
    names(phi_ij) <- paste0("Phi_", M_ij[upper.tri(M_ij)])
    # Formatting the output
    out <-
        c(v_plas, phi_i / v_plas, phi_ij / v_plas) |>
        as.list() |>
        as.data.frame()
    
    # If V_Plas was provided, compute M²
    if (provided_v_plas) {
        out[["M2"]] <- poly_v_plas / v_plas
    }
    return(out)
}
Any scripts or data that you put into this service are public.
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.