syncsa: SYNCSA

Description Usage Arguments Details Value Note Author(s) References See Also Examples

Description

This function integrates several steps for the analysis of phylogenetic assembly patterns and their links to traits and ecological processes in a metacommunity (Pillar et al. 2009, Pillar & Duarte 2010, Debastiani & Pillar 2012). The function implement methods that have been available in the SYNCSA application written in C++ (by Valerio Pillar, available at http://ecoqua.ecologia.ufrgs.br/SYNCSA.html). See details.

Usage

 1
 2
 3
 4
 5
 6
 7
 8
 9
10
11
12
13
14
15
16
17
18
19
20
21
22
23
syncsa(
  comm,
  traits = NULL,
  phylodist = NULL,
  envir = NULL,
  checkdata = TRUE,
  ro.method = "mantel",
  method = "pearson",
  dist = "euclidean",
  scale = TRUE,
  scale.envir = TRUE,
  ranks = TRUE,
  ord,
  put.together = NULL,
  na.rm = FALSE,
  strata = NULL,
  permutations = 999,
  parallel = NULL,
  notification = TRUE
)

## S3 method for class 'syncsa'
print(x, ...)

Arguments

comm

Community data, with species as columns and sampling units as rows. This matrix can contain either presence/absence or abundance data. Alternatively comm can be an object of class metacommunity.data, an alternative way to set all data.frames/matrices. When you use the class metacommunity.data the arguments traits, phylodist, envir and put.together must be null. See details.

traits

Data frame or matrix data of species described by traits, with traits as columns and species as rows (Default traits = NULL).

phylodist

Matrix containing phylogenetic distance between species. Must be a complete matrix, not a half diagonal matrix (Default phylodist = NULL).

envir

Environmental variables for each community, with variables as columns and sampling units as rows (Default envir = NULL).

checkdata

Logical argument (TRUE or FALSE) to check if species sequence in the community data follows the same order as the one in the trait and in the phylodist matrices and if sampling units in the community data follows the same order as the one in the environmental data (Default checkdata = TRUE).

ro.method

Method to obtain the correlation, "mantel" or "procrustes" (Default ro.method = "mantel").

method

Mantel correlation method, as accepted by cor: "pearson", "spearman" or "kendall" (Default method = "pearson").

dist

Dissimilarity index used for Mantel correlation, as accepted by vegdist: "manhattan", "euclidean", "canberra", "bray", "kulczynski", "jaccard", "gower", "altGower", "morisita", "horn", "mountford", "raup" , "binomial" or "chao" (Default dist = "euclidean").

scale

Logical argument (TRUE or FALSE) to specify if the traits are measured on different scales (Default Scale = TRUE). When scale = TRUE traits are measured on different scales the the matrix T is subjected to standardization within each trait. When scale = FALSE traits are measured on the same scale and the matrix T is not subjected to standardization. Furthermore, if scale = TRUE the matrix of traits is subjected to standardization within each trait, and Gower Index is used to calculate the degree of belonging to the species, and if scale = FALSE the matrix of traits is not subjected to standardization, and Euclidean distance is calculated to determine the degree of belonging to the species.

scale.envir

Logical argument (TRUE or FALSE) to specify if the environmental variables are measured on different scales. If the enviromental variables are measured on different scales, the scale.envir = TRUE the matrix with enviromental variables is subjected to centralization and standardization within each variable. (Default scale.envir = TRUE).

ranks

Logical argument (TRUE or FALSE) to specify if ordinal variables are convert to ranks (Default ranks = TRUE).

ord

Method to be used for ordinal variables, see gowdis.

put.together

List to specify group of traits. Each group specify receive the same weight that one trait outside any group, in the way each group is considered as unique trait (Default put.together = NULL). This argument must be a list, see examples.

na.rm

Logical argument (TRUE or FALSE) to specify if pairwise distances should be deleted in cases of missing observations (Default na.rm = FALSE).

strata

Strata named vector to specify restricting permutations within species groups (Default strata = NULL).

permutations

Number of permutations in assessing significance.

parallel

Number of parallel processes. Tip: use parallel::detectCores() (Default parallel = NULL).

notification

Logical argument (TRUE or FALSE) to specify if notification of missing observations should to be shown (Default notification = TRUE).

x

An object of class syncsa.

...

Other parameters for the respective functions.

Details

Package SYNCSA requires that the species and community sequence in the data.frame or matrix must be the same for all dataframe/matrices. The function organize.syncsa organizes the data for the functions of the package, placing the matrices of community, traits, phylogenetic distance, environmental varibles and strata vector in the same order. The function use of function organize.syncsa is not requered for run the functions, but is recommended. It requires data organized into the following matrices: (1) the presences or abundances of species in a set of communities (W); (2) the phylogenetic pairwise dissimilarities of these species (DF); (3) a set of functional traits describing the species (B), which may be a mixture of binary and quantitative traits (continual and ordinal), but not nominal ones (these should be expanded into binary traits); and (4) the ecological gradient of interest, which may be one or more factors to which the communities respond or ecosystem effects of the communities (E). In this way the arguments comm, traits, phylodist, envir, as well as the arguments put.together and strata, can be specified them as normal arguments or by passing them with the object returned by the function organize.syncsa using, in this case only the argument comm. Using the object returned by organize.syncsa, the comm argument is used as an alternative way of entering to set all data.frames/matrices, and therefore the other arguments (traits, phylodist, envir, put.together and strata) must be null.

Correlations

The function computes several correlations (Mantel or Procrustes) that express trait-convergence assembly patterns (TCAP), trait-divergence assembly patterns (TDAP), and phylogenetic signal in functional traits at the species pool level and at the metacomunity level. This function also generates P-values by permutation testing based on null models (Pillar et al. 2009, Pillar & Duarte 2010).

ro(TE)

This correlation refers to trait-convergence assembly patterns related to the ecological gradient (TCAP, Pillar et al. 2009). For evaluating TCAP, by matrix multiplication we define T = WB, which with previous standardization of W to unit column totals will contain the trait averages in each community. The elements in T are community weighted mean values or community functional parameters (Violle et al. 2007). Standardization of the traits (rows) in T is needed if the trait set contains traits measured with different scales. By using matrix correlation, we evaluate how the trait patterns in T are associated to ecological gradients in E. For relating T to E, using Mantel correlation we define a distance matrix of the communities (DT) using T, and another distance matrix of the community sites (DE) using E. The matrix correlation ro(TE) = ro(DT;DE) measures the level of congruence between TCAP and E. A strong correlation ro(TE) indicates the factors directly or indirectly represented in E are involved in ecological filtering of species that, at least for the traits considered in the analysis, consistently produce trait-convergence assembly patterns along the gradient comprising the metacommunity.

ro(XE) and ro(XE.T)

These matrix correlations refer to trait-divergence assembly patterns related to the ecological gradient (TDAP, Pillar et al. 2009). For the identification of TDAP, in a first step the species pairwise similarities (in the range 0 to 1) in matrix SB based on traits in B are used to define matrix U with degrees of belonging of species to fuzzy sets. By matrix multiplication X = WU will contain the species composition of the communities after fuzzy-weighting by their trait similarities (each row in X will refer to a species). Matrix X expresses both TCAP and TDAP (Pillar et al. 2009). By using matrix correlation, we evaluate how the trait patterns in X (TCAP and TDAP) are associated to ecological gradients in E. For relating X to E, we define a distance matrix of the communities (DX) using X, and another distance matrix of the community sites (DE) using E. The matrix correlation ro(XE) = ro(DX;DE) between X and E is defined. We then remove the trait-convergence component ro(TE) from ro(XE) by computing the partial matrix correlation ro(XE.T), which measures the level of congruence between TDAP and E. Trait-divergence assembly patterns (TDAP, Pillar et al. 2009) may result from community assembly processes related to biotic interactions (Stubbs & Wilson 2004; Wilson 2007).

ro(PE)

This matrix correlation refers to the phylogenetic structure related to the ecological gradient comprising the metacommunity. The phylogenetic pairwise dissimilarities in DF are transformed into similarities and used to define degrees of belonging qij to fuzzy sets. This is analogous to the definition of functional fuzzy sets (Pillar & Orloci 1991; Pillar et al. 2009). Based on the phylogenetic similarities, every species i among s species in the metacommunity specifies a fuzzy set to which every species j (j = 1 to s species, including species i) belongs with a certain degree of belonging in the interval [0, 1]. In our definition, each row in matrix Q with the degrees of belonging must add to unit, i.e., the degrees of belonging of a given species across the fuzzy sets are standardized to unit total. By matrix multiplication P = WQ will contain the composition of the communities after fuzzy-weighting of species presences or abundances by the species' phylogenetic similarities. Each column in matrix P holds the phylogenetic structure of a community. The standardization of Q is essential for the community totals in each column in W remaining the same in P. Further, matrix W is adjusted to unit column totals prior to multiplication, so that the total richness or abundance within each community in W will be standardized. Matrix correlation ro(PE) = ro(DP;DE) measures the strength of the association between community distances based on their phylogenetic structure in DP and distances based on their ecological conditions (DE). Further, P can be explored for phylogenetic patterns at the metacommunity level by using, e.g., ordination techniques.

ro(PT) and ro(PX.T)

These matrix correlations measure phylogenetic signal at the metacommunity level related to TCAP and to TDAP. We define phylogenetic signal at the metacommunity level related to TCAP (PSMT) as the correlation between the phylogenetic structure described in matrix P and the trait-convergence structure described in matrix T. For this, a proper distance matrix (e.g. Euclidean distances) of communities (DP) is computed using P and another distance matrix of the same communities (DT) is computed using T. Then matrix correlation ro(PT) = ro(DP;DT) will measure the level of congruence between variation in P and T, which is a measure of PSMT. A strong phylogenetic signal at the metacommunity level is expected when communities that are more similar in terms of phylogenetic structure are also similar regarding their average trait values. We also define phylogenetic signal at the metacommunity level related to TDAP (PSMX.T) as the partial matrix correlation ro(PX.T) = ro(DP;DX.DT) between community distances DP computed on phylogenetic structure and community distances DX computed on species composition after fuzzy-weighting by the species, or trait similarities, removing the effect of TCAP (DT). This is analogous to TDAP.

ro(BF)

This matrix correlation measures phylogenetic signal at the species pool level (PSS, Pillar & Duarte 2010). We define PSS as the matrix correlation ro(FB) = ro(DF;DB) between species phylogenetic dissimilarities (already defined as matrix DF) and species trait dissimilarities (derived from already defined matrix SB) computed on any number of traits from matrix B. The species pool refers to the species present in the metacommunity.

Additional matrix correlations

The matrix correlations ro(TE.P) and ro(XE.P) are also computed, which may be useful for evaluating causal models in path analysis.

Mantel correlations

The Mantel and Partial Mantel statistics are calculated simply as the correlation entries the dissimilarity matrices, using standard Mantel test (see mantel and cor.mantel). Partial Mantel statistic use paired correlation between the three matrices and obtains the partial correlation using the formula of first-order partial correlation coefficient. The significances are obtained using a different procedure than standard Mantel test, see section Testing against null models below.

Procrustes correlations

The Procrustes correlation uses symmetric Procrustes as a measure of concordance between the data matrices (see procrustes and cor.procrustes). Procrustes procedure use rotation, translation, and rescaling for minimizing sum of squared differences between two data sets. The correlation of Procrustes is calculated as the statistic derived from the symmetric Procrustes sum of squares, representing the optimal fit between the two data matrices. Partial Procrustes correlation is obtained by Procrustes correlation between residuals matrices. Firstly one Principal Components Analysis (PCA, see prcomp) is performed in the matrix Z for dimensionality reduction. The max number of axis kept in the analysis is the number of sampling units divided by 2, this axes of PCA represent the total variation in the Z matrix. After the kept axes are used as predictor in one linear model for each variable of the matrices X and Y. For this a linear model is build using as response one variable of X (same via for Y matrix) and as predictor all remaining axes of PCA, after model fitted and the residual are extracted with the aim of form the residual matrix. The linear model is repeated in the other variables, only with the changed the response variable. The same procedure is performed in the matrix Y. Both residual matrices are submitted to Procrustes analysis and the statistic is returned as a partial correlation, the Partial Procrustes statistic. The significances are obtained using the same procedure than Mantel test, see section Testing against null models below.

Testing against null models

All the matrix correlations are tested against null models. The null model is defined accoding to the correlation being tested. Usually in the SYNCSA package the null models are based in permutation of species rather than permutation of sample units. For ro(TE),each permutation generates a random matrix T calculated after the permutation among the species vectors in matrix B. For ro(XE) and ro(XE.T), each permutation generates a random matrix X after the permutation among species fuzzy sets (rows) in matrix U. For ro(PE), ro(PT), and ro(PX.T), each permutation generates a random matrix P after the permutation among species fuzzy sets (rows) in matrix Q. For ro(BF), a conventional Mantel test is performed with dissimilarity matrices DF and DB. Analogous null models are used for testing the additional matrix correlations; that is, the same null model for ro(TE) is used for ro(TE.P), the same model for ro(XE) is used for ro(XE.P). The permutation can be restrict within species groups specifying the strata argument.

Traits types

Traits data can be numeric, factor or ordered factor. For this be considered in the analyses traits data must be of data.frame class and containing each variable type determined. Gower index is used to calculate the similarity between species, using the function gowdis of package FD. For additional details and requirements of function please see gowdis.

Missing data

The functions ignore missing data when specified. In the case of direct multiplication of matrices the missing data are replaced by 0, ignoring the cell with missing value. For the matrix T = WB an adjustment is done by divide each cell of the product matrix (T) by the sum of species proportion with trait data in B. Result matrices are shown without missing values. Where the matrices are calculated using a dissimilarity index (matrix U and correlations between matrices) the missing data are ignored as in vegdist function. In some cases the dissimilarity matrices obtained by the function vegdist still contain some missing values. In these cases the rest of the procedure will be affected. In these cases you can find solutions in impute the missing values.

Error messenger and options

The data pass by several ckeck points that can produce error messenger. The matrices or data frames must be contain only numeric, binary or ordinal variables, in the way that nominal variable should be expanded into binary (see var.dummy). For enhance the code speed some functions use by default matrix algebra, this option can produce error under certain circumstances. This global option can be changed using options("SYNCSA.speed" = FALSE). If SYNCSA.speed = TRUE for use matrix algebra and if SYNCSA.speed = FALSE use not another function of same procedure.

Value

call

The arguments used.

notes

Some notes about the statistics.

statistics

Correlations roTE, roXE, roPE, roPT, roPX.T, roXE.T, roTE.P, roXE.P and roBF, and their significance levels based on permutations.

matrices

The matrices produced for the functions, see details.

FunRao

Rao quadratic entropy within each community, considering trait distance.

weights

Weight for each trait.

Note

The function calculates the correlations despite the lack of one of the matrices, provided that community data had been entered. Correlations including unspecified matrices will appear with NA.

IMPORTANT: The sequence of species in the community data matrix MUST be the same as that in the phylogenetic distance matrix and in traits matrix. Similarly, the sequence of communities in the community data matrix MUST be the same as that in the environmental data. See details and organize.syncsa.

Author(s)

Vanderlei Julio Debastiani <vanderleidebastiani@yahoo.com.br>

References

Debastiani, V.J & Pillar, V.D., (2012). SYNCSA-R tool for analysis of metacommunities based on functional traits and phylogeny of the community components. Bioinformatics, 28(15), 2067–2068.

Pillar, V.D.; Duarte, L.d.S., (2010). A framework for metacommunity analysis of phylogenetic structure. Ecology Letters, 13, 587:596.

Pillar, V.D., Duarte, L.d.S., Sosinski, E.E. & Joner, F. (2009). Discriminating trait-convergence and trait-divergence assembly patterns in ecological community gradients. Journal of Vegetation Science, 20, 334:348.

Pillar, V.D. & Orloci, L., (1991). Fuzzy components in community level comparisons. In: Computer Assisted Vegetation Analysis (eds Feoli, E. & Orloci, L.). Kluwer, Dordrecht, 87:93.

Stubbs, W.J. & Wilson, J.B., (2004). Evidence for limiting similarity in a sand dune community. Journal of Ecology, 92, 557:567.

Violle, C., Navas, M.L., Vile, D., Kazakou, E., Fortunel, C., Hummel, I. & Garnier, E., (2007). Let the concept of trait be functional! Oikos, 116, 882:892.

Wilson, J.B., (2007). Trait-divergence assembly rules have been demonstrated: limiting similarity lives! A reply to Grime. Journal of Vegetation Science, 18, 451:452.

See Also

organize.syncsa, matrix.t, matrix.x, matrix.p, optimal, rao.diversity, cor.matrix, var.type, var.dummy

Examples

1
2
3
4
5
6
7
8
data(ADRS)
syncsa(ADRS$community, ADRS$traits, ADRS$phylo, ADRS$envir, permutations = 99)
data(flona)
put.together<-list(c("fol","sem"), c("tam", "red"))
put.together
res<-syncsa(flona$community, flona$traits, envir = flona$environment,
   put.together = put.together, permutations = 99)
res$weights

Example output

Call:
syncsa(comm = ADRS$community, traits = ADRS$traits, phylodist = ADRS$phylo,      envir = ADRS$envir, permutations = 99) 

Notes:
            Correlation meanings                                                                                             
note.roTE   "Trait-convergence assembly patterns (TCAP): roTE"                                                               
note.roXE   "Both trait-convergence assembly patterns and trait-divergence assembly patterns: roXE"                          
note.roXE.T "Trait-divergence assembly patterns (TDAP): roXE.T"                                                              
note.roBF   "Phylogenetic signal at species level: roBF"                                                                     
note.roPE   "Correlation of phylogenetically structured assembly patterns to ecological variables: roPE"                     
note.roPT   "Correlation of phylogenetically structured assembly patterns to trait-convergence assembly patterns: roPT"      
note.roPX.T "Correlation of phylogenetically structured assembly patterns to trait-divergence assembly patterns: roPX.T"     
note.roTE.P "Removing phylogeny from trait-convergence assembly patterns: roTE.P"                                            
note.roXE.P "Removing phylogeny from both trait-convergence assembly patterns and trait-divergence assembly patterns: roXE.P"

Statistics:
       Obs         p   
roTE   -0.02525696 0.91
roXE   -0.03556669 0.8 
roPE   -0.03239541 0.73
roPT   0.8258717   0.32
roPX.T 0.1613383   0.69
roXE.T -0.05394669 0.77
roTE.P 0.002657195 0.99
roXE.P -0.01561222 0.89
roBF   0.5595638   0.06
[[1]]
[1] "fol" "sem"

[[2]]
[1] "tam" "red"

fol sem fru tam red 
0.5 0.5 1.0 0.5 0.5 

SYNCSA documentation built on Jan. 11, 2020, 9:26 a.m.

Related to syncsa in SYNCSA...