This document presents the codes and plots used for the analysis related to the manuscript Evaluation of an adapted semi-automated DNA extraction for human salivary shotgun metagenomics. In this project, we evaluated the impact of two DNA extraction procedures on the overall DNA quantity and quality, the sequencing performances and the overall structure and composition of the oral microbiome. Salivary samples were obtained from 14 patients recruited in the RAPSODI study and the PD FRONTLINE platform, using the OMNIgene•ORAL OM-501 sample collection kit (DNAGenotek), and processed using P1 and P2 protocols as described in Figure 1 on the manuscript. The libraries construction and shotgun sequencing using Ion Torrent technology was fully described in PMID: 36369227, and the raw read processing in PMID: 32075887.

1 Load

  • Load necessary R packages :
library(ggpubr)
suppressMessages(library(stringr))
suppressMessages(library(tidyverse))
library(reshape2)
require(ggplot2)
require(pheatmap)
library(data.table)
library(Hmisc)
library(kableExtra)
library(scales)
require(pheatmap)
library(data.table)
library(vegan)
library(FactoMineR)
library(factoextra)
library(ComplexHeatmap, lib.loc = "/usr/lib64/R/library")
library(circlize)
# Install the momr package available forgemia.inra.fr qand published in Le Chatelier E, Nielsen T, Qin J, Prifti E, Hildebrand F, Falony G, et al. Richness of human gut microbiome correlates with metabolic markers. Nature. 2013;500(7464):541–6
# remotes::install_gitlab("metagenopolis/momr", host = "https://forgemia.inra.fr/") 
library(momr)
  • Load data and metadata :
load("./data/microbial_data_ASAL_paper_2023.RData") #RData containing microbial table abundances and taxonomy file
load(file ="./data/metadata_ASAL_2023.RData") # Associated ASAL metadata

2 Impact on DNA quantity and DNA quality

2.1 DNA quantity and quality

  • protocol:
Qdna_plot <- ggplot(metadata.asal, aes(x=protocol, y = DNA_MTQ_ug, color = protocol))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(method = "wilcox.test", label.x =0.8, label.y= 1.5) +
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("DNA quantity (µg)")+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())
genomic_plot <- ggplot(metadata.asal, aes(x=protocol, y = genomic_peak_size_bp, color = protocol))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(method = "wilcox.test", label.x =1, label.y = 30000) +
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("Genomic peak size(bp)")+
  scale_y_continuous(labels = function(x) format(x, scientific = TRUE))+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())
# tiff("./figures/DNAquantity_DNA_quality_protocol.tiff", width = 8, height = 3, units = "in", res=400)
ggarrange(Qdna_plot, genomic_plot, ncol=2, nrow=1, legend = "none")

# dev.off()

No significant difference for DNA quantity. The size of the genomic peak is significantly higher in the P1 protocol.

  • protocol and sample type :
Qdna_plot_pt <- ggplot(metadata.asal, aes(x=protocol_type, y = DNA_MTQ_ug, color = protocol_type))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(method = "wilcox.test", comparisons = list(c("P1_raw", "P1_pooled"), c("P2_raw", "P2_pooled"), c("P1_raw", "P2_raw"), c("P1_pooled", "P2_pooled")),exact = FALSE)+
  scale_color_manual(values = c("P1_raw" = "cyan4", "P1_pooled" = "cyan3", "P2_raw" = "hotpink4", "P2_pooled" = "hotpink3"))+
  ylab("DNA quantity (µg)")+
  rotate_x_text(angle=45)+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())
# tiff("./figures/DNAquantity_protocol_type.tiff", width = 8, height = 5, units = "in", res=400)
Qdna_plot_pt

# dev.off()

There is no impact on the DNA quantity

genomic_plot_pt <- ggplot(metadata.asal, aes(x=protocol_type, y = genomic_peak_size_bp, color = protocol_type))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(method = "wilcox.test", comparisons = list(c("P1_raw", "P1_pooled"), c("P2_raw", "P2_pooled"), c("P1_raw", "P2_raw"), c("P1_pooled", "P2_pooled")), exact = FALSE)+
  scale_color_manual(values = c("P1_raw" = "cyan4", "P1_pooled" = "cyan3", "P2_raw" = "hotpink4", "P2_pooled" = "hotpink3"))+
  ylab("Mean size genomic peak (bp)")+
  rotate_x_text(angle=45)+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())+
  scale_y_continuous(labels = function(x) format(x, scientific = TRUE))
# tiff("./figures/DNAgenomic_quality_protocol_type.tiff", width = 8, height = 5, units = "in", res=400)
genomic_plot_pt

# dev.off()

P1_raw and P1_pooled are equivalent. The DNA quality of P2_raw is the lowest.

2.2 DNA degradation profiles (protocol)

f1_plot <- ggplot(metadata.asal, aes(x=protocol, y = as.numeric(fraction1_perc), color = protocol))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(label.x =1, label.y = 55) +
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("fraction1_perc")+
  rotate_x_text(angle=45)+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())+
  theme(legend.position= "none")
f2_plot <- ggplot(metadata.asal, aes(x=protocol, y = as.numeric(fraction2_perc), color = protocol))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(label.x =1, label.y = 28) +
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("fraction2_perc")+
  rotate_x_text(angle=45)+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())+
  theme(legend.position= "none")
f3_plot <- ggplot(metadata.asal, aes(x=protocol, y = as.numeric(fraction3_perc), color = protocol))+
  geom_boxplot()+
  theme_classic() +
  stat_compare_means(label.x =1, label.y = 100) +
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("fraction3_perc")+
  rotate_x_text(angle=45)+
  theme(legend.text = element_text(size=12), axis.text=element_text(size=10), axis.title.x = element_blank())
# tiff("./figures/DNA_degradation_profiles_per_protocol.tiff", width = 12, height = 3, units = "in", res=400)
ggarrange(f1_plot, f2_plot, f3_plot, ncol=3, nrow=1, widths = c(1,1,1.4))

# dev.off()

No significance for fraction1 (the smaller DNA fraction size) and fraction3 (containing the genomic peak) but a significantly higher proportion of the DNA fraction 2 (degraded fraction) in the P2 protocol.

3 Shotgun Metagenomic Sequencing Validation

3.1 Total read count and removed host read count (protocol)

data <- reshape2::melt(metadata.asal[,c("protocol", "total_read_count", "removed_host_reads_count")], id.vars = c("protocol"))
# tiff("./figures/total_read_host_read_protocol.tiff", width = 7, height = 3.5, units = "in", res=400)
ggboxplot(data, x="protocol", y="value", color="protocol")+
  stat_compare_means()+
  theme(axis.text=element_text(size=10))+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("read values")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  theme(legend.text = element_text(size=7), legend.position = "none")+
  facet_wrap(~variable, scales = "free_y")

# dev.off()

No significant differences.

3.2 High Quality read count

# tiff("./figures/High_quality_read_protocol.tiff", width = 4, height = 3, units = "in", res=400)
HQ_read_plot <- ggboxplot(metadata.asal, x="protocol", y="HQ_clean_read_count", color="protocol")+
  theme_classic()+
  theme(axis.text=element_text(size=10))+
  ylab("High Quality read count")+
  stat_compare_means(label.x = 1, label.y = 1.5e7)+
  theme(legend.text = element_text(size=7))+
  theme(legend.position = "none")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))
HQ_read_plot

# dev.off()

No significant difference.

3.3 Mapping rates onto the 8.4M human oral microbial genes catalog

# tiff("./figures/perc_mapped_reads_procotol.tiff", width = 4, height = 3, units = "in", res=400)
perc_mapped <- ggboxplot(metadata.asal, x="protocol", y="perc_mapped_read_8.4oral", color="protocol")+
  theme_classic()+
  theme(axis.text=element_text(size=10))+
  ylab("% Mapped Reads")+
  stat_compare_means(label.x = 1, label.y = 65)+
  theme(legend.text = element_text(size=7))+
  theme(legend.position = "none")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))
perc_mapped

# dev.off()

No significant difference.

4 Evaluation of the impact on alpha diversity metrics (gene and MSP species richness)

4.1 Correlation of gene and MSP species richness with the DNA quality

correl_gene_plot <- ggscatter(metadata.asal,
          x="genomic_peak_size_bp",
          y="gene.richness",
          color = "protocol",
          add="reg.line",
          conf.int=TRUE,
          shape = "type",
          add.params=list(color="black", fill="lightgray")) +
  geom_smooth(formula = 'y ~ x', method = "lm")+
  stat_cor(method="spearman")+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  theme(legend.position = "right")
correl_msp_plot <- ggscatter(metadata.asal,
          x="genomic_peak_size_bp",
          y="msp.richness",
          color = "protocol",
          add="reg.line",
          conf.int=TRUE,
          shape = "type",
          add.params=list(color="black", fill="lightgray")) +
  geom_smooth(formula = 'y ~ x', method = "lm")+
  stat_cor(method="spearman")+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  theme(legend.position = "right")

# tiff("./figures/correlation_gene_species_richness_genomic_peak_protocol.tiff", width = 8, height = 3, units = "in", res=400)
ggarrange(correl_gene_plot,correl_msp_plot, ncol=2,nrow=1, common.legend = TRUE, legend = "right")

# dev.off()

4.2 Impact of the protocol on richness data of the pooled

-all samples (raw and pooled):

gene_plot <- ggboxplot(metadata.asal, x="protocol", y="gene.richness", color="protocol")+
  stat_compare_means()+
  theme(axis.text=element_text(size=10))+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("gene richness")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  theme(legend.text = element_text(size=7), legend.position = "none")+
  ggtitle("all samples")

msp_plot <- ggboxplot(metadata.asal, x="protocol", y="msp.richness", color="protocol")+
  stat_compare_means()+
  theme(axis.text=element_text(size=10))+
  scale_color_manual(values = c("P1" = "cyan4", "P2" = "hotpink4"))+
  ylab("MSP richness")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  theme(legend.text = element_text(size=7), legend.position = "none")+
  ggtitle("all samples")

# tiff("./figures/gene_msp_richness_protocol.tiff", width = 6, height = 3, units = "in", res=400)
ggarrange(gene_plot,msp_plot, ncol=2, nrow=1,  legend = "none")

# dev.off()

No significant difference.

-pooled samples:

pooled_gene_plot <- ggboxplot(metadata.asal[which(metadata.asal$type == "pooled"),], x="protocol_type", y="gene.richness", color="protocol_type")+
  stat_compare_means()+
  theme(axis.text=element_text(size=10))+
  scale_color_manual(values = c("P1_pooled" = "cyan3", "P2_pooled" = "hotpink3"))+
  ylab("gene richness")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  theme(legend.text = element_text(size=7), legend.position = "none")
pooled_msp_plot <- ggboxplot(metadata.asal[which(metadata.asal$type == "pooled"),], x="protocol_type", y="msp.richness", color="protocol_type")+
  stat_compare_means()+
  theme(axis.text=element_text(size=10))+
  scale_color_manual(values = c("P1_pooled" = "cyan3", "P2_pooled" = "hotpink3"))+
  ylab("species richness")+
  theme(axis.text.x = element_text(angle = 45, vjust = 1, hjust=1))+
  theme(legend.text = element_text(size=7), legend.position = "none")

# tiff("./figures/gene_species_richness_protocol_pooled_samples.tiff", width = 6, height = 3, units = "in", res=400)
ggarrange(pooled_gene_plot,pooled_msp_plot, ncol=2,nrow=1, legend = "none")

# dev.off()

No significant difference.

5 Impact on the oral microbiome structure

5.1 Spearman correlation based on gene composition

ann <- data.frame(metadata.asal$protocol, metadata.asal$Pool_sample)
colnames(ann) <- c('protocol', 'Pool_sample')

colours <- list('protocol' = c("P1" = "cyan4", "P2" = "hotpink4"),'Pool_sample' = c("ind1"="azure2", "ind2"="firebrick1", "ind3"="grey", "ind4"="orange", "ind5"="darkorchid1", "ind6"="blue", "ind7"="darkgreen", "ind8"="dodgerblue2", "ind9/ind12"="gold1", "ind10/ind13"="chartreuse3", "ind11/ind14"="hotpink"))

colAnn <- HeatmapAnnotation(df = ann, which = 'col', col = colours, annotation_width = unit(c(1, 4), 'cm'), gap = unit(1, 'mm'))

# tiff(file = "./figures/Heatmap_gene_correlation.tiff", height = 5, width = 8, units = "in", res = 300)
ht <- Heatmap(as.matrix(gene.correlation.mat),
        clustering_method_rows = "ward.D",clustering_method_columns = "ward.D",
        clustering_distance_rows = "spearman", clustering_distance_columns = "spearman",
        name = "Sp correlation",
        col = colorRamp2(seq(min(gene.correlation.mat), max(gene.correlation.mat), length = 3), c("red", "yellow", "white")),
        column_names_gp = gpar(fontsize = 7),
        row_names_gp = gpar(fontsize = 7),
        top_annotation=colAnn)
ht

# dev.off()

Pooled samples of 2 individuals extracted with P1 and P2 protocols clustered together.

5.2 PCA based on MSP species composition

#Ordering msp.mat as metadata
msp.mat<-msp.oral.asal[,match(rownames(metadata.asal), colnames(msp.oral.asal))]
#setting rownames with taxonomy
rownames(msp.mat)<-paste(rownames(msp.mat), taxo[match(rownames(msp.mat), rownames(taxo)), "species"], sep="_")
# PCA analysis
data_for_pca <- t(log10(msp.mat + 1e-10) + 10)
data<- cbind(data_for_pca, metadata.asal[match(rownames(data_for_pca), rownames(metadata.asal)),c(3:5)])
res<-PCA(data, quali.sup = c(854:856), graph=FALSE)
# tiff(file = "./figures/PCA_MSP_species_protocol.tiff", height = 4.5, width = 5.5, units = "in", res = 300)
pca_plot <- fviz_pca_ind(res,   axes= c(1,2),
             # label = "all",
             label = "none",
             col.ind = data$protocol,
             geom.ind = "point", pointshape = 18, pointsize = 2,
             palette = c("P1" = "cyan4", "P2" = "hotpink4"),
             addEllipses = TRUE, ellipse.level=0.95,
             invisible="quali",
             # title="PCA on MSP species composition",
             repel = TRUE)
pca_plot

# dev.off()

Pooled samples extracted from P1 and P2 protocols clustered together. No specific clustering by P1 and P2 protocols.

5.3 Speaman correlations based on MSP composition

msp.mat = msp.oral.asal[,metadata.asal$sampleID]
data = Hmisc::rcorr(as.matrix(msp.mat), type = "spearman")
data_to_plot = data$r
# tiff(file = "./figures/Heatmap_MSP_correlation",width = 8, height = 6,  units = "in", res = 300)
Heatmap(as.matrix(data_to_plot), 
        clustering_method_rows = "ward.D",clustering_method_columns = "ward.D",
        clustering_distance_rows = "spearman", clustering_distance_columns = "spearman",
        name = "Sp correlation",
        col = colorRamp2(seq(min(data_to_plot), max(data_to_plot), length = 3), c("red", "yellow", "white")),
        column_names_gp = gpar(fontsize = 7), 
        row_names_gp = gpar(fontsize = 6),
        top_annotation=colAnn)

# dev.off()

5.4 Bray curtis dissimilarity matrix using MSP species composition

data = t(log10(msp.oral.asal + 1e-10) + 10)
BC = as.matrix(vegdist(data, method = "bray", diag = TRUE, upper= FALSE, na.rm = FALSE))

ann_colors = list(
  protocol = c(P1="cyan4", P2="hotpink4"),
  'Pool_sample' = c("ind1"="azure2", "ind2"="firebrick1", "ind3"="grey", "ind4"="orange", "ind5"="darkorchid1", "ind6"="blue", "ind7"="darkgreen", "ind8"="dodgerblue2", "ind9/ind12"="gold1", "ind10/ind13"="chartreuse3", "ind11/ind14"="hotpink")
  )

# tiff(file = "./figures/Bray-curtis_MSP_composition.tiff",width = 8, height = 6,  units = "in", res = 300)
pheatmap(as.matrix(BC), 
         clustering_distance_rows = "euclidean",
         clustering_distance_cols = "euclidean",
         # annotation_col=metadata.asal[-which(metadata.asal$fraction == "degraded"),c(3:4,9)],
         annotation_col=metadata.asal[,c("protocol", "Pool_sample")],
         annotation_colors=ann_colors,
         clustering_method = "ward.D2",         
         fontsize_row=5, fontsize_col=5,
         show_colnames = F, show_rownames = F,
         dendrogram="both", key=FALSE, treeheight_row=40,
         treeheight_col=40
         ) 

# dev.off()

5.5 Analysis at different taxonomical ranks on the pooled samples

5.5.1 phylum on pooled samples

phylum.t <- as.data.frame(t(phylum)) #15 phyla
phylum.t <- phylum.t[,colSums(phylum.t)>0] #12 phyla ok
phylum.t$protocol_type <- metadata.asal[match(rownames(phylum.t), rownames(metadata.asal)), "protocol_type"]
data <- melt(phylum.t, id.vars = c("protocol_type"))
data$protocol_type <- factor(data$protocol_type, levels = c("P2_raw", "P2_pooled","P1_raw", "P1_pooled"))

# tiff(file = "./figures/Phylum_composition_pooled_samples_protocol.tiff", height = 10, width = 5.5, units = "in", res = 300)
phylum_plot <- ggplot(data[which(data$protocol_type == "P1_pooled" | data$protocol_type == "P2_pooled"),], aes(x=reorder(variable, value, na.rm =TRUE), y=value)) +
  geom_boxplot(aes(fill=protocol_type), outlier.size = 0.1)+
  labs(x = "Phylum rank")+
  labs(y="Relative abundance")+
  scale_y_log10(breaks = trans_breaks("log10", function(x) 10^x),labels = trans_format("log10", math_format(10^.x))) +
  scale_fill_manual(values = c("P1_pooled" = "cyan3", "P2_pooled" = "hotpink3"))+
  coord_flip()+
  theme_classic()
phylum_plot

# dev.off()
# impact of the protocol on the phylum relative abundance of the pooled samples
res.phylum <- testRelations2(x = as.matrix(phylum[,which(metadata.asal$type == "pooled")]), y = as.factor(metadata.asal[which(metadata.asal$type == "pooled"), "protocol"]), type = "nonparametric", multiple.adjust = "BH", paired = F)
## [1] "Executing Wilcoxon test..."
res.phylum[,c(10:13)]%>%
  kbl(caption = "pvalues Wilcoxon tests") %>%
  kable_classic(full_width = F, html_font = "Cambria")
pvalues Wilcoxon tests
p q P1.P2_Cliffdelta P1.P2_status_Cliffdeltacorrected
Actinobacteriota 0.7000000 0.9333333 -0.3333333 P2
Bacteroidota 1.0000000 1.0000000 0.1111111 P1
Campylobacterota 0.7000000 0.9333333 0.3333333 P1
Chloroflexota NaN NaN 0.0000000 NA
Desulfobacterota 1.0000000 1.0000000 -0.1111111 P2
Elusimicrobiota NaN NaN 0.0000000 NA
Eukaryota 0.7000000 0.9333333 -0.3333333 P2
Euryarchaeota NaN NaN 0.0000000 NA
Firmicutes 0.7000000 0.9333333 0.3333333 P1
Fusobacteriota 0.1000000 0.6000000 1.0000000 P1
Patescibacteria 0.1000000 0.6000000 1.0000000 P1
Proteobacteria 1.0000000 1.0000000 -0.1111111 P2
Spirochaetota 0.4000000 0.9333333 0.5555556 P1
Synergistetes 0.6579050 0.9333333 -0.3333333 P2
unclassified 0.1840386 0.7361545 0.7777778 P1

No significant differences between pooled samples extracted with P1 or P2 protocols (p> 0.05).

5.5.2 family on pooled samples

fam.t <- as.data.frame(t(family)) #80
fam.t <- fam.t[rownames(metadata.asal),colSums(fam.t)>0] #55 fam remains
fam.t$protocol_type <- metadata.asal[match(rownames(fam.t), rownames(metadata.asal)), "protocol_type"]
data <- melt(fam.t, id.vars = c("protocol_type"))
data$protocol_type <- factor(data$protocol_type, levels = c("P2_raw", "P2_pooled","P1_raw", "P1_pooled"))
data2 <- data[which(data$protocol_type == "P1_pooled" | data$protocol_type == "P2_pooled"),]
# tiff(file = "./figures/Family_composition_pooled_samples_protocol.tiff", height = 10, width = 5.5, units = "in", res = 300)
family_plot <- ggplot(data2[data2$value>0,], aes(x=reorder(variable, value, na.rm =TRUE), y=value)) +
  geom_boxplot(aes(fill=protocol_type), outlier.size = 0.1)+
  labs(x = "Family rank")+
  labs(y="Relative abundance")+
  scale_y_log10(breaks = trans_breaks("log10", function(x) 10^x), labels = trans_format("log10", math_format(10^.x)))+
  scale_fill_manual(values = c("P1_pooled" = "cyan3", "P2_pooled" = "hotpink3"))+
  coord_flip()+
  theme_classic()
family_plot

# dev.off()
# impact of the protocol on the family relative abundance of the pooled samples
res.fam <- testRelations2(x = as.matrix(family[,which(metadata.asal$type == "pooled")]), y = as.factor(metadata.asal[which(metadata.asal$type == "pooled"), "protocol"]), type = "nonparametric", multiple.adjust = "BH", paired = F)
## [1] "Executing Wilcoxon test..."
res.fam[,c(10:13)]%>%
  kbl(caption = "pvalues Wilcoxon tests") %>%
  kable_classic(full_width = F, html_font = "Cambria")
pvalues Wilcoxon tests
p q P1.P2_Cliffdelta P1.P2_status_Cliffdeltacorrected
Actinomycetaceae 0.4000000 0.8153846 0.5555556 P1
Aerococcaceae 0.1000000 0.3785714 1.0000000 P1
Aminobacteriaceae 0.6579050 0.9048780 -0.3333333 P2
Anaerolineaceae NaN NaN 0.0000000 NA
Anaerovoracaceae 0.1000000 0.3785714 1.0000000 P1
Atopobiaceae 1.0000000 1.0000000 0.1111111 P1
Bacillaceae NaN NaN 0.0000000 NA
Bacilli RF39 CAG-611 0.0636026 0.3785714 1.0000000 P1
Bacteroidaceae 0.1000000 0.3785714 1.0000000 P1
Bifidobacteriaceae 0.5049851 0.8949141 -0.3333333 P2
Bradyrhizobiaceae NaN NaN 0.0000000 NA
Brucellaceae NaN NaN 0.0000000 NA
Burkholderiaceae 0.1840386 0.5047619 0.7777778 P1
Campylobacteraceae 0.7000000 0.9048780 0.3333333 P1
Cardiobacteriaceae 0.5065552 0.8949141 0.4444444 P1
Carnobacteriaceae NaN NaN 0.0000000 NA
Caulobacteraceae NaN NaN 0.0000000 NA
Clostridiales 1c 1.0000000 1.0000000 -0.1111111 P2
Clostridiales 2g 0.0765225 0.3785714 1.0000000 P1
Corynebacteriaceae 0.1000000 0.3785714 1.0000000 P1
Desulfobulbaceae 1.0000000 1.0000000 -0.1111111 P2
Desulfomicrobiaceae NaN NaN 0.0000000 NA
Desulfovibrionaceae NaN NaN 0.0000000 NA
Dethiosulfovibrionaceae NaN NaN 0.0000000 NA
Dialisteraceae 1.0000000 1.0000000 0.1111111 P1
Eggerthellaceae 0.1967056 0.5047619 -0.6666667 P2
Endomicrobiaceae NaN NaN 0.0000000 NA
Enterobacteriaceae NaN NaN 0.0000000 NA
Enterococcaceae NaN NaN 0.0000000 NA
Erysipelatoclostridiaceae NaN NaN 0.0000000 NA
Erysipelotrichaceae 0.2000000 0.5047619 0.7777778 P1
Eubacteriaceae 0.5049851 0.8949141 -0.3333333 P2
Eukaryota 0.7000000 0.9048780 -0.3333333 P2
Filifactoraceae 0.8247781 1.0000000 -0.2222222 P2
Flavobacteriaceae 0.1000000 0.3785714 1.0000000 P1
Fusobacteriaceae 0.1000000 0.3785714 1.0000000 P1
Gemellaceae 0.4000000 0.8153846 0.5555556 P1
Helcococcaceae-Ezakiellaceae 0.7000000 0.9048780 -0.3333333 P2
Helicobacteraceae NaN NaN 0.0000000 NA
Lachnospiraceae B NaN NaN 0.0000000 NA
Lachnospiraceae D 0.2000000 0.5047619 0.7777778 P1
Lachnospiraceae H 0.4000000 0.8153846 0.5555556 P1
Lachnospiraceae K 0.0765225 0.3785714 1.0000000 P1
Lactobacillaceae NaN NaN 0.0000000 NA
Leptotrichiaceae 0.7000000 0.9048780 0.3333333 P1
Megasphaeraceae 0.7000000 0.9048780 0.3333333 P1
Metamycoplasmataceae 1.0000000 1.0000000 -0.1111111 P2
Methanobacteriaceae NaN NaN 0.0000000 NA
Micrococcaceae 0.7000000 0.9048780 0.3333333 P1
Moraxellaceae NaN NaN 0.0000000 NA
Neisseriaceae 1.0000000 1.0000000 0.1111111 P1
Paludibacteraceae 0.7000000 0.9048780 -0.3333333 P2
Pasteurellaceae 1.0000000 1.0000000 0.1111111 P1
Peptococcaceae NaN NaN 0.0000000 NA
Peptoniphilaceae NaN NaN 0.0000000 NA
Peptostreptococcaceae 0.4000000 0.8153846 0.5555556 P1
Porphyromonadaceae 0.7000000 0.9048780 0.3333333 P1
Prevotellaceae 1.0000000 1.0000000 -0.1111111 P2
Propionibacteriaceae 0.1967056 0.5047619 0.6666667 P1
Pseudomonadaceae NaN NaN 0.0000000 NA
Rhodocyclaceae NaN NaN 0.0000000 NA
Rikenellaceae 2 1.0000000 1.0000000 -0.1111111 P2
Rikenellaceae 3 1.0000000 1.0000000 -0.1111111 P2
Saccharimonadaceae 0.1000000 0.3785714 1.0000000 P1
Selenomonadaceae 1.0000000 1.0000000 0.1111111 P1
Staphylococcaceae NaN NaN 0.0000000 NA
Streptococcaceae 0.1000000 0.3785714 1.0000000 P1
Synergistaceae NaN NaN 0.0000000 NA
Tannerellaceae 0.7000000 0.9048780 -0.3333333 P2
Treponemataceae 0.4000000 0.8153846 0.5555556 P1
unclassified 0.1840386 0.5047619 0.7777778 P1
unclassified Absconditabacterales 0.0765225 0.3785714 1.0000000 P1
unclassified Bacteroidales 0.1967056 0.5047619 0.6666667 P1
unclassified Bacteroidota NaN NaN 0.0000000 NA
unclassified Clostridiales 2 0.0636026 0.3785714 1.0000000 P1
unclassified Gracilibacteria BD1-5 0.5049851 0.8949141 0.3333333 P1
unclassified Mycoplasmatales NaN NaN 0.0000000 NA
Veillonellaceae 0.7000000 0.9048780 0.3333333 P1
Weeksellaceae 0.1000000 0.3785714 1.0000000 P1
Xanthomonadaceae NaN NaN 0.0000000 NA

No significant differences between pooled samples extracted with P1 or P2 protocols (p> 0.05).

5.5.3 genus on pooled sample

gen.t <- as.data.frame(t(genus)) #163
gen.t <- gen.t[rownames(metadata.asal),colSums(gen.t)>0] #86 gen remains
gen.t$protocol_type <- metadata.asal[match(rownames(gen.t), rownames(metadata.asal)), "protocol_type"]
data <- melt(gen.t, id.vars = c("protocol_type"))
data$protocol_type <- factor(data$protocol_type, levels = c("P2_raw", "P2_pooled","P1_raw", "P1_pooled"))
data3 <- data[which(data$protocol_type == "P1_pooled" | data$protocol_type == "P2_pooled"),]
# tiff(file = "./figures/Genus_composition_pooled_samples_protocol.tiff", height = 10, width = 5.5, units = "in", res = 300)
genus_plot <- ggplot(data3[data3$value>0,], aes(x=reorder(variable, value, na.rm =TRUE), y=value)) +
  geom_boxplot(aes(fill=protocol_type), outlier.size = 0.1)+
  labs(x = "Genus rank")+
  labs(y="Relative abundance")+
  scale_y_log10(breaks = trans_breaks("log10", function(x) 10^x), labels = trans_format("log10", math_format(10^.x)))+
  scale_fill_manual(values = c("P1_pooled" = "cyan3", "P2_pooled" = "hotpink3"))+
  coord_flip()+
  theme_classic()
genus_plot

# dev.off()
# impact of the protocol on the genus relative abundance of the pooled samples
res.genus <- testRelations2(x = as.matrix(genus[,which(metadata.asal$type == "pooled")]), y = as.factor(metadata.asal[which(metadata.asal$type == "pooled"), "protocol"]), type = "nonparametric", multiple.adjust = "BH", paired = F)
## [1] "Executing Wilcoxon test..."
res.genus[,c(10:13)]%>%
  kbl(caption = "pvalues Wilcoxon tests") %>%
  kable_classic(full_width = F, html_font = "Cambria")
pvalues Wilcoxon tests
p q P1.P2_Cliffdelta P1.P2_status_Cliffdeltacorrected
Abiotrophia 0.1967056 0.5379310 0.6666667 P1
Acinetobacter NaN NaN 0.0000000 NA
Actinobaculum 0.0636026 0.4105263 1.0000000 P1
Actinomyces 0.7000000 0.8950820 0.3333333 P1
Actinomycetaceae F0332 NaN NaN 0.0000000 NA
Afipia NaN NaN 0.0000000 NA
Aggregatibacter 0.1000000 0.4105263 1.0000000 P1
Allisonella 1.0000000 1.0000000 -0.1111111 P2
Alloprevotella 0.4000000 0.8063531 0.5555556 P1
Alloscardovia NaN NaN 0.0000000 NA
Alternaria NaN NaN 0.0000000 NA
Anaerococcus NaN NaN 0.0000000 NA
Anaeroglobus 0.7000000 0.8950820 0.3333333 P1
Aspergillus NaN NaN 0.0000000 NA
Atopobium 1.0000000 1.0000000 0.1111111 P1
Bacilli RF39 CAG-611 RUG343 0.1967056 0.5379310 0.6666667 P1
Bacillus NaN NaN 0.0000000 NA
Bacteroides NaN NaN 0.0000000 NA
Bacteroides 2 0.5049851 0.8063531 -0.3333333 P2
Bacteroides 3 NaN NaN 0.0000000 NA
Bifidobacterium 0.5049851 0.8063531 -0.3333333 P2
Bradyrhizobium NaN NaN 0.0000000 NA
Brevundimonas NaN NaN 0.0000000 NA
Butyrivibrio NaN NaN 0.0000000 NA
Campylobacter 0.7000000 0.8950820 0.3333333 P1
Candida NaN NaN 0.0000000 NA
Capnocytophaga 0.1000000 0.4105263 1.0000000 P1
Cardiobacterium 0.5065552 0.8063531 0.4444444 P1
Catonella 0.0765225 0.4105263 1.0000000 P1
Caviibacter NaN NaN 0.0000000 NA
Chryseobacterium 0.1000000 0.4105263 1.0000000 P1
Corynebacterium 0.1000000 0.4105263 1.0000000 P1
Cronobacter NaN NaN 0.0000000 NA
Cryptobacterium NaN NaN 0.0000000 NA
Cutibacterium NaN NaN 0.0000000 NA
Delftia NaN NaN 0.0000000 NA
Desulfobulbus 1.0000000 1.0000000 -0.1111111 P2
Desulfomicrobium NaN NaN 0.0000000 NA
Desulfovibrio NaN NaN 0.0000000 NA
Dialister 1.0000000 1.0000000 0.1111111 P1
Dolosigranulum NaN NaN 0.0000000 NA
Eggerthella NaN NaN 0.0000000 NA
Eggerthia NaN NaN 0.0000000 NA
Eikenella 0.0765225 0.4105263 1.0000000 P1
Endomicrobium NaN NaN 0.0000000 NA
Enterobacter NaN NaN 0.0000000 NA
Enterococcus NaN NaN 0.0000000 NA
Escherichia NaN NaN 0.0000000 NA
Eubacterium 0.2000000 0.5379310 0.7777778 P1
Eubacterium 2 NaN NaN 0.0000000 NA
Filifactor 1.0000000 1.0000000 0.0000000 NA
Finegoldia NaN NaN 0.0000000 NA
Fretibacterium 0.6579050 0.8950820 -0.3333333 P2
Fusobacterium 0.1000000 0.4105263 1.0000000 P1
Gemella 0.4000000 0.8063531 0.5555556 P1
Gongronella NaN NaN 0.0000000 NA
Granulicatella 0.1000000 0.4105263 1.0000000 P1
Haemophilus 1.0000000 1.0000000 0.1111111 P1
Helicobacter NaN NaN 0.0000000 NA
Johnsonella 0.3536785 0.8063531 -0.5555556 P2
Jonquetella NaN NaN 0.0000000 NA
Kingella 0.0765225 0.4105263 1.0000000 P1
Klebsiella NaN NaN 0.0000000 NA
Kluyvera NaN NaN 0.0000000 NA
Lachancea NaN NaN 0.0000000 NA
Lachnoanaerobaculum 0.1000000 0.4105263 1.0000000 P1
Lactobacillus NaN NaN 0.0000000 NA
Lactobacillus B NaN NaN 0.0000000 NA
Lactobacillus C NaN NaN 0.0000000 NA
Lactobacillus F NaN NaN 0.0000000 NA
Lactobacillus G NaN NaN 0.0000000 NA
Lactobacillus H NaN NaN 0.0000000 NA
Lactococcus NaN NaN 0.0000000 NA
Lautropia 0.1840386 0.5379310 0.7777778 P1
Lentinus NaN NaN 0.0000000 NA
Leptotrichia 0.7000000 0.8950820 0.3333333 P1
Lysinibacillus NaN NaN 0.0000000 NA
Malassezia NaN NaN 0.0000000 NA
Megasphaera NaN NaN 0.0000000 NA
Metamycoplasma 1.0000000 1.0000000 -0.1111111 P2
Methanobrevibacter NaN NaN 0.0000000 NA
Mitsuokella 0.5049851 0.8063531 0.3333333 P1
Mobiluncus 0.5049851 0.8063531 0.3333333 P1
Mogibacterium 0.4000000 0.8063531 0.5555556 P1
Moraxella NaN NaN 0.0000000 NA
Nakaseomyces NaN NaN 0.0000000 NA
Neisseria 1.0000000 1.0000000 0.1111111 P1
Ochrobactrum NaN NaN 0.0000000 NA
Olsenella 1.0000000 1.0000000 0.1111111 P1
Oribacterium 1.0000000 1.0000000 0.1111111 P1
Ottowia NaN NaN 0.0000000 NA
Paenarthrobacter NaN NaN 0.0000000 NA
Paraprevotella NaN NaN 0.0000000 NA
Parascardovia NaN NaN 0.0000000 NA
Parvimonas 1.0000000 1.0000000 -0.1111111 P2
Pauljensenia 0.4000000 0.8063531 0.5555556 P1
Penicillium NaN NaN 0.0000000 NA
Peptoanaerobacter 1.0000000 1.0000000 0.1111111 P1
Peptoniphilus NaN NaN 0.0000000 NA
Peptostreptococcus 0.4000000 0.8063531 0.5555556 P1
Phocaeicola 0.5049851 0.8063531 -0.3333333 P2
Pichia NaN NaN 0.0000000 NA
Porphyromonas 0.7000000 0.8950820 0.3333333 P1
Prevotella 1.0000000 1.0000000 -0.1111111 P2
Prevotellamassilia 0.1000000 0.4105263 1.0000000 P1
Propionibacterium NaN NaN 0.0000000 NA
Propionimicrobium NaN NaN 0.0000000 NA
Propionivibrio NaN NaN 0.0000000 NA
Proteus NaN NaN 0.0000000 NA
Pseudomonas NaN NaN 0.0000000 NA
Pseudopropionibacterium 0.1967056 0.5379310 0.6666667 P1
Pseudoramibacter 0.5049851 0.8063531 -0.3333333 P2
Puccinia NaN NaN 0.0000000 NA
Pyramidobacter NaN NaN 0.0000000 NA
Ralstonia NaN NaN 0.0000000 NA
Rhizophagus NaN NaN 0.0000000 NA
Rhizopus NaN NaN 0.0000000 NA
Rikenellaceae 2 RC9 1.0000000 1.0000000 -0.1111111 P2
Rothia 0.7000000 0.8950820 0.3333333 P1
Saccharomyces NaN NaN 0.0000000 NA
Scardovia NaN NaN 0.0000000 NA
Selenomonas 1.0000000 1.0000000 0.1111111 P1
Selenomonas 2 0.7000000 0.8950820 -0.3333333 P2
Shuttleworthia 0.5049851 0.8063531 0.3333333 P1
Slackia 0.1967056 0.5379310 -0.6666667 P2
Sneathia NaN NaN 0.0000000 NA
Solobacterium 0.2000000 0.5379310 0.7777778 P1
Staphylococcus NaN NaN 0.0000000 NA
Stenotrophomonas NaN NaN 0.0000000 NA
Stomatobaculum 0.4000000 0.8063531 0.5555556 P1
Streptobacillus NaN NaN 0.0000000 NA
Streptococcus 0.1000000 0.4105263 1.0000000 P1
Synergistes NaN NaN 0.0000000 NA
Talaromyces NaN NaN 0.0000000 NA
Tannerella 0.7000000 0.8950820 -0.3333333 P2
Treponema 0.4000000 0.8063531 0.5555556 P1
unclassified 0.1840386 0.5379310 0.7777778 P1
unclassified Absconditabacterales 0.0765225 0.4105263 1.0000000 P1
unclassified Anaerolineaceae NaN NaN 0.0000000 NA
unclassified Anaerovoracaceae 0.5049851 0.8063531 0.3333333 P1
unclassified Atopobiaceae NaN NaN 0.0000000 NA
unclassified Bacilli RF39 CAG-611 0.0636026 0.4105263 1.0000000 P1
unclassified Bacteroidales 0.1967056 0.5379310 0.6666667 P1
unclassified Bacteroidota NaN NaN 0.0000000 NA
unclassified Clostridiales 1c 1.0000000 1.0000000 -0.1111111 P2
unclassified Clostridiales 2 0.0636026 0.4105263 1.0000000 P1
unclassified Clostridiales 2g 0.0765225 0.4105263 1.0000000 P1
unclassified Corynebacteriaceae NaN NaN 0.0000000 NA
unclassified Eukaryota 0.7000000 0.8950820 -0.3333333 P2
unclassified Gracilibacteria BD1-5 0.5049851 0.8063531 0.3333333 P1
unclassified Helcococcaceae 0.5049851 0.8063531 -0.3333333 P2
unclassified Lachnospiraceae D 0.1967056 0.5379310 0.6666667 P1
unclassified Lachnospiraceae H 0.1000000 0.4105263 1.0000000 P1
unclassified Mycoplasmatales NaN NaN 0.0000000 NA
unclassified Neisseriaceae NaN NaN 0.0000000 NA
unclassified Paludibacteraceae 0.7000000 0.8950820 -0.3333333 P2
unclassified Peptococcaceae NaN NaN 0.0000000 NA
unclassified Propionibacteriaceae NaN NaN 0.0000000 NA
unclassified Rikenellaceae 3 1.0000000 1.0000000 -0.1111111 P2
unclassified Saccharimonadaceae 0.1000000 0.4105263 1.0000000 P1
unclassified Selenomonadaceae 0.3536785 0.8063531 -0.5555556 P2
Variovorax NaN NaN 0.0000000 NA
Veillonella 0.7000000 0.8950820 0.3333333 P1

No significant differences between pooled samples extracted with P1 or P2 protocols (p> 0.05).

5.5.4 MSP species on pooled samples

# impact of the protocol on the MSP species relative abundance of the pooled samples
res.msp <- testRelations2(x = as.matrix(msp.oral.asal[,which(metadata.asal$type == "pooled")]), y = as.factor(metadata.asal[which(metadata.asal$type == "pooled"), "protocol"]), type = "nonparametric", multiple.adjust = "BH", paired = F)
## [1] "Executing Wilcoxon test..."
res.msp[,c(10:13)]%>%
  kbl(caption = "pvalues Wilcoxon tests") %>%
  kable_classic(full_width = F, html_font = "Cambria")
pvalues Wilcoxon tests
p q P1.P2_Cliffdelta P1.P2_status_Cliffdeltacorrected
msp_0005 NaN NaN 0.0000000 NA
msp_0026 NaN NaN 0.0000000 NA
msp_0030 NaN NaN 0.0000000 NA
msp_0069 NaN NaN 0.0000000 NA
msp_0108 NaN NaN 0.0000000 NA
msp_0146c 0.7000000 1 -0.3333333 P2
msp_0148c 0.4000000 1 0.5555556 P1
msp_0166 NaN NaN 0.0000000 NA
msp_0197 NaN NaN 0.0000000 NA
msp_0206 NaN NaN 0.0000000 NA
msp_0212 0.4000000 1 -0.5555556 P2
msp_0228 NaN NaN 0.0000000 NA
msp_0241 NaN NaN 0.0000000 NA
msp_0295 NaN NaN 0.0000000 NA
msp_0313 0.7000000 1 0.3333333 P1
msp_0380 0.4000000 1 -0.5555556 P2
msp_0403 NaN NaN 0.0000000 NA
msp_0408 NaN NaN 0.0000000 NA
msp_0409 NaN NaN 0.0000000 NA
msp_0437c 0.7000000 1 -0.3333333 P2
msp_0446c 1.0000000 1 0.1111111 P1
msp_0469c NaN NaN 0.0000000 NA
msp_0482 NaN NaN 0.0000000 NA
msp_0486 NaN NaN 0.0000000 NA
msp_0497 NaN NaN 0.0000000 NA
msp_0570 NaN NaN 0.0000000 NA
msp_0573 NaN NaN 0.0000000 NA
msp_0574c NaN NaN 0.0000000 NA
msp_0603c 1.0000000 1 -0.1111111 P2
msp_0610 0.7000000 1 -0.3333333 P2
msp_0616 0.6428348 1 -0.3333333 P2
msp_0627 NaN NaN 0.0000000 NA
msp_0677c 1.0000000 1 0.1111111 P1
msp_0691 NaN NaN 0.0000000 NA
msp_0712 NaN NaN 0.0000000 NA
msp_0715c 0.3758251 1 -0.5555556 P2
msp_0742 0.1000000 1 -1.0000000 P2
msp_0833 NaN NaN 0.0000000 NA
msp_0844c 1.0000000 1 -0.1111111 P2
msp_0853c 1.0000000 1 0.1111111 P1
msp_0854 NaN NaN 0.0000000 NA
msp_0864 1.0000000 1 0.1111111 P1
msp_0881 1.0000000 1 0.1111111 P1
msp_0884 0.7000000 1 0.3333333 P1
msp_0916 NaN NaN 0.0000000 NA
msp_0925 NaN NaN 0.0000000 NA
msp_0935 NaN NaN 0.0000000 NA
msp_0974c 0.4000000 1 -0.5555556 P2
msp_1006 NaN NaN 0.0000000 NA
msp_1028c 1.0000000 1 -0.1111111 P2
msp_1034 0.6428348 1 -0.3333333 P2
msp_1040c 1.0000000 1 0.1111111 P1
msp_1057c NaN NaN 0.0000000 NA
msp_1081 NaN NaN 0.0000000 NA
msp_1089 NaN NaN 0.0000000 NA
msp_1127 0.0636026 1 -1.0000000 P2
msp_1156 0.4000000 1 0.5555556 P1
msp_1191c 0.5049851 1 0.3333333 P1
msp_1193 1.0000000 1 0.0000000 NA
msp_1196 NaN NaN 0.0000000 NA
msp_1219 0.7000000 1 0.3333333 P1
msp_1220 NaN NaN 0.0000000 NA
msp_1222 NaN NaN 0.0000000 NA
msp_1234 1.0000000 1 0.1111111 P1
msp_1237 NaN NaN 0.0000000 NA
msp_1265 NaN NaN 0.0000000 NA
msp_1268 NaN NaN 0.0000000 NA
msp_1325 0.7000000 1 0.3333333 P1
msp_1327 1.0000000 1 0.1111111 P1
msp_1329 1.0000000 1 0.0000000 NA
msp_1341 NaN NaN 0.0000000 NA
msp_1404 NaN NaN 0.0000000 NA
msp_1410 NaN NaN 0.0000000 NA
msp_1418c 0.7000000 1 -0.3333333 P2
msp_1453 0.6428348 1 -0.3333333 P2
msp_1456c 1.0000000 1 0.1111111 P1
msp_1476 NaN NaN 0.0000000 NA
msp_1477 0.5049851 1 0.3333333 P1
msp_1489c NaN NaN 0.0000000 NA
msp_1523 NaN NaN 0.0000000 NA
msp_1543 1.0000000 1 -0.1111111 P2
msp_1603c 0.4000000 1 0.5555556 P1
msp_1702 0.2000000 1 -0.7777778 P2
msp_1748 1.0000000 1 0.0000000 NA
msp_1773 NaN NaN 0.0000000 NA
msp_1782 1.0000000 1 0.1111111 P1
msp_1783 1.0000000 1 0.1111111 P1
msp_1784 1.0000000 1 0.1111111 P1
msp_1785 1.0000000 1 0.0000000 NA
msp_1786 1.0000000 1 -0.1111111 P2
msp_1787 1.0000000 1 0.1111111 P1
msp_1788 1.0000000 1 -0.1111111 P2
msp_1789 0.7000000 1 -0.3333333 P2
msp_1790 0.7000000 1 0.3333333 P1
msp_1793 0.7000000 1 0.3333333 P1
msp_1794 NaN NaN 0.0000000 NA
msp_1799 NaN NaN 0.0000000 NA
msp_1801 0.8247781 1 0.2222222 P1
msp_1802 1.0000000 1 -0.1111111 P2
msp_1805 NaN NaN 0.0000000 NA
msp_1808 1.0000000 1 -0.1111111 P2
msp_1810 NaN NaN 0.0000000 NA
msp_2212 0.8247781 1 0.2222222 P1
msp_2213 0.8247781 1 0.2222222 P1
msp_2214 0.7000000 1 -0.3333333 P2
msp_2215 0.0765225 1 -1.0000000 P2
msp_2216 1.0000000 1 0.1111111 P1
msp_2217 0.2000000 1 -0.7777778 P2
msp_2218 1.0000000 1 0.1111111 P1
msp_2219 0.8247781 1 0.2222222 P1
msp_2220 0.4000000 1 0.5555556 P1
msp_2221 NaN NaN 0.0000000 NA
msp_2222 0.7000000 1 -0.3333333 P2
msp_2223 0.8247781 1 0.2222222 P1
msp_2224 1.0000000 1 0.1111111 P1
msp_2225 0.7000000 1 0.3333333 P1
msp_2226 0.2000000 1 0.7777778 P1
msp_2227 1.0000000 1 -0.1111111 P2
msp_2228 1.0000000 1 0.1111111 P1
msp_2229 NaN NaN 0.0000000 NA
msp_2230 0.7000000 1 -0.3333333 P2
msp_2231 1.0000000 1 0.1111111 P1
msp_2232 1.0000000 1 0.0000000 NA
msp_2233 0.5049851 1 -0.3333333 P2
msp_2234 NaN NaN 0.0000000 NA
msp_2235 1.0000000 1 0.0000000 NA
msp_2236 1.0000000 1 0.1111111 P1
msp_2237 0.5049851 1 -0.3333333 P2
msp_2238 NaN NaN 0.0000000 NA
msp_2239 0.7000000 1 -0.3333333 P2
msp_2240 0.7000000 1 0.3333333 P1
msp_2241 0.5049851 1 -0.3333333 P2
msp_2242 0.7000000 1 0.3333333 P1
msp_2243 0.7000000 1 -0.3333333 P2
msp_2244 1.0000000 1 -0.1111111 P2
msp_2245 0.7000000 1 0.3333333 P1
msp_2246 0.8247781 1 0.2222222 P1
msp_2247 0.1967056 1 0.6666667 P1
msp_2248 0.5049851 1 -0.3333333 P2
msp_2249 0.4000000 1 -0.5555556 P2
msp_2250 1.0000000 1 -0.1111111 P2
msp_2251 1.0000000 1 -0.1111111 P2
msp_2252 1.0000000 1 0.0000000 NA
msp_2253 NaN NaN 0.0000000 NA
msp_2254 1.0000000 1 0.1111111 P1
msp_2255 0.6428348 1 -0.3333333 P2
msp_2256 1.0000000 1 -0.1111111 P2
msp_2257 NaN NaN 0.0000000 NA
msp_2258 NaN NaN 0.0000000 NA
msp_2259 NaN NaN 0.0000000 NA
msp_2260 NaN NaN 0.0000000 NA
msp_2261 1.0000000 1 -0.1111111 P2
msp_2262 0.5049851 1 0.3333333 P1
msp_2263 0.7000000 1 -0.3333333 P2
msp_2264 1.0000000 1 0.1111111 P1
msp_2265 1.0000000 1 0.1111111 P1
msp_2266 0.7000000 1 0.3333333 P1
msp_2267 1.0000000 1 0.0000000 NA
msp_2268 0.7000000 1 0.3333333 P1
msp_2269 1.0000000 1 0.1111111 P1
msp_2270 1.0000000 1 0.1111111 P1
msp_2271 0.7000000 1 -0.3333333 P2
msp_2272 NaN NaN 0.0000000 NA
msp_2273 0.8247781 1 -0.2222222 P2
msp_2274 1.0000000 1 0.1111111 P1
msp_2275 NaN NaN 0.0000000 NA
msp_2276 1.0000000 1 -0.1111111 P2
msp_2277 0.7000000 1 0.3333333 P1
msp_2278 NaN NaN 0.0000000 NA
msp_2279 0.5049851 1 -0.3333333 P2
msp_2280 NaN NaN 0.0000000 NA
msp_2281 NaN NaN 0.0000000 NA
msp_2282 NaN NaN 0.0000000 NA
msp_2283 1.0000000 1 -0.1111111 P2
msp_2284 NaN NaN 0.0000000 NA
msp_2285 0.5049851 1 -0.3333333 P2
msp_2286 0.4000000 1 0.5555556 P1
msp_2287 0.6579050 1 -0.3333333 P2
msp_2288 1.0000000 1 -0.1111111 P2
msp_2289 1.0000000 1 0.1111111 P1
msp_2290 NaN NaN 0.0000000 NA
msp_2291 NaN NaN 0.0000000 NA
msp_2292 0.8247781 1 -0.2222222 P2
msp_2293 1.0000000 1 -0.1111111 P2
msp_2294 1.0000000 1 0.0000000 NA
msp_2295 NaN NaN 0.0000000 NA
msp_2296 1.0000000 1 -0.1111111 P2
msp_2297 1.0000000 1 0.1111111 P1
msp_2298 NaN NaN 0.0000000 NA
msp_2299 NaN NaN 0.0000000 NA
msp_2300 1.0000000 1 0.1111111 P1
msp_2301 1.0000000 1 -0.1111111 P2
msp_2302 0.4000000 1 -0.5555556 P2
msp_2303 1.0000000 1 0.1111111 P1
msp_2304 0.5049851 1 0.3333333 P1
msp_2305 1.0000000 1 0.1111111 P1
msp_2306 NaN NaN 0.0000000 NA
msp_2307 NaN NaN 0.0000000 NA
msp_2308 NaN NaN 0.0000000 NA
msp_2309 NaN NaN 0.0000000 NA
msp_2310 NaN NaN 0.0000000 NA
msp_2311 NaN NaN 0.0000000 NA
msp_2312 1.0000000 1 0.0000000 NA
msp_2313 0.5049851 1 0.3333333 P1
msp_2314 NaN NaN 0.0000000 NA
msp_2315 0.7000000 1 0.3333333 P1
msp_2316 NaN NaN 0.0000000 NA
msp_2317 NaN NaN 0.0000000 NA
msp_2318 0.5049851 1 -0.3333333 P2
msp_2319 NaN NaN 0.0000000 NA
msp_2320 0.5049851 1 -0.3333333 P2
msp_2321 1.0000000 1 -0.1111111 P2
msp_2322 0.7000000 1 -0.3333333 P2
msp_2323 0.5049851 1 -0.3333333 P2
msp_2324 1.0000000 1 -0.1111111 P2
msp_2325 1.0000000 1 0.1111111 P1
msp_2326 1.0000000 1 0.0000000 NA
msp_2327 1.0000000 1 0.0000000 NA
msp_2328 NaN NaN 0.0000000 NA
msp_2329 1.0000000 1 -0.1111111 P2
msp_2330 NaN NaN 0.0000000 NA
msp_2331 NaN NaN 0.0000000 NA
msp_2332 1.0000000 1 0.1111111 P1
msp_2333 1.0000000 1 0.1111111 P1
msp_2334 0.5049851 1 -0.3333333 P2
msp_2335 0.6428348 1 -0.3333333 P2
msp_2336 NaN NaN 0.0000000 NA
msp_2337 NaN NaN 0.0000000 NA
msp_2338 1.0000000 1 -0.1111111 P2
msp_2339 1.0000000 1 -0.1111111 P2
msp_2340 NaN NaN 0.0000000 NA
msp_2341 1.0000000 1 0.0000000 NA
msp_2342 1.0000000 1 0.1111111 P1
msp_2343 0.5049851 1 -0.3333333 P2
msp_2344 NaN NaN 0.0000000 NA
msp_2345 1.0000000 1 0.1111111 P1
msp_2346 1.0000000 1 0.1111111 P1
msp_2347 0.3536785 1 0.5555556 P1
msp_2348 0.8247781 1 -0.2222222 P2
msp_2349 NaN NaN 0.0000000 NA
msp_2350 0.6428348 1 0.3333333 P1
msp_2351 1.0000000 1 -0.1111111 P2
msp_2352 1.0000000 1 0.1111111 P1
msp_2353 1.0000000 1 0.0000000 NA
msp_2354 1.0000000 1 -0.1111111 P2
msp_2355 1.0000000 1 0.1111111 P1
msp_2356 0.5049851 1 -0.3333333 P2
msp_2357 1.0000000 1 0.1111111 P1
msp_2358 0.5065552 1 0.4444444 P1
msp_2359 1.0000000 1 -0.1111111 P2
msp_2360 NaN NaN 0.0000000 NA
msp_2361 0.8247781 1 -0.2222222 P2
msp_2362 NaN NaN 0.0000000 NA
msp_2363 1.0000000 1 -0.1111111 P2
msp_2364 NaN NaN 0.0000000 NA
msp_2365 NaN NaN 0.0000000 NA
msp_2366 0.5049851 1 0.3333333 P1
msp_2367 0.1967056 1 -0.6666667 P2
msp_2368 1.0000000 1 0.1111111 P1
msp_2369 NaN NaN 0.0000000 NA
msp_2370 1.0000000 1 0.1111111 P1
msp_2371 0.8247781 1 -0.2222222 P2
msp_2372 1.0000000 1 -0.1111111 P2
msp_2373 1.0000000 1 -0.1111111 P2
msp_2374 NaN NaN 0.0000000 NA
msp_2375 1.0000000 1 -0.1111111 P2
msp_2376 0.3758251 1 0.5555556 P1
msp_2377 1.0000000 1 0.0000000 NA
msp_2378 1.0000000 1 0.1111111 P1
msp_2379 NaN NaN 0.0000000 NA
msp_2380 NaN NaN 0.0000000 NA
msp_2381 NaN NaN 0.0000000 NA
msp_2382 NaN NaN 0.0000000 NA
msp_2383 0.6428348 1 -0.3333333 P2
msp_2384 1.0000000 1 0.1111111 P1
msp_2385 0.8247781 1 0.2222222 P1
msp_2386 1.0000000 1 0.0000000 NA
msp_2387 0.5049851 1 -0.3333333 P2
msp_2388 NaN NaN 0.0000000 NA
msp_2389 0.5049851 1 -0.3333333 P2
msp_2390 1.0000000 1 0.0000000 NA
msp_2391 0.6428348 1 0.3333333 P1
msp_2392 1.0000000 1 -0.1111111 P2
msp_2393 0.7000000 1 0.3333333 P1
msp_2394 0.5065552 1 -0.4444444 P2
msp_2395 0.5049851 1 -0.3333333 P2
msp_2396 1.0000000 1 0.1111111 P1
msp_2397 0.4000000 1 -0.5555556 P2
msp_2398 1.0000000 1 -0.1111111 P2
msp_2399 NaN NaN 0.0000000 NA
msp_2400 1.0000000 1 0.1111111 P1
msp_2401 1.0000000 1 -0.1111111 P2
msp_2402 1.0000000 1 0.0000000 NA
msp_2403 NaN NaN 0.0000000 NA
msp_2404 1.0000000 1 -0.1111111 P2
msp_2405 NaN NaN 0.0000000 NA
msp_2406 NaN NaN 0.0000000 NA
msp_2407 1.0000000 1 -0.1111111 P2
msp_2408 NaN NaN 0.0000000 NA
msp_2409 0.7000000 1 -0.3333333 P2
msp_2410 0.5049851 1 -0.3333333 P2
msp_2411 0.5049851 1 0.3333333 P1
msp_2412 NaN NaN 0.0000000 NA
msp_2413 NaN NaN 0.0000000 NA
msp_2414 NaN NaN 0.0000000 NA
msp_2415 1.0000000 1 -0.1111111 P2
msp_2416 NaN NaN 0.0000000 NA
msp_2417 NaN NaN 0.0000000 NA
msp_2418 1.0000000 1 0.1111111 P1
msp_2419 NaN NaN 0.0000000 NA
msp_2420 1.0000000 1 0.1111111 P1
msp_2421 NaN NaN 0.0000000 NA
msp_2422 NaN NaN 0.0000000 NA
msp_2423 1.0000000 1 0.1111111 P1
msp_2424 NaN NaN 0.0000000 NA
msp_2425 NaN NaN 0.0000000 NA
msp_2426 NaN NaN 0.0000000 NA
msp_2427 NaN NaN 0.0000000 NA
msp_2428 1.0000000 1 0.0000000 NA
msp_2429 NaN NaN 0.0000000 NA
msp_2430 NaN NaN 0.0000000 NA
msp_2431 NaN NaN 0.0000000 NA
msp_2432 NaN NaN 0.0000000 NA
msp_2433 NaN NaN 0.0000000 NA
msp_2434 0.8247781 1 0.2222222 P1
msp_2435 NaN NaN 0.0000000 NA
msp_2436 0.3536785 1 -0.5555556 P2
msp_2437 1.0000000 1 0.1111111 P1
msp_2438 1.0000000 1 -0.1111111 P2
msp_2439 0.8247781 1 -0.2222222 P2
msp_2440 1.0000000 1 -0.1111111 P2
msp_2441 NaN NaN 0.0000000 NA
msp_2442 NaN NaN 0.0000000 NA
msp_2443 1.0000000 1 0.1111111 P1
msp_2444 1.0000000 1 -0.1111111 P2
msp_2445 1.0000000 1 -0.1111111 P2
msp_2446 NaN NaN 0.0000000 NA
msp_2447 NaN NaN 0.0000000 NA
msp_2448 0.6428348 1 0.3333333 P1
msp_2449 NaN NaN 0.0000000 NA
msp_2450 1.0000000 1 0.1111111 P1
msp_2451 1.0000000 1 0.1111111 P1
msp_2452 NaN NaN 0.0000000 NA
msp_2453 NaN NaN 0.0000000 NA
msp_2454 NaN NaN 0.0000000 NA
msp_2455 1.0000000 1 0.1111111 P1
msp_2456 1.0000000 1 0.1111111 P1
msp_2457 1.0000000 1 0.1111111 P1
msp_2458 NaN NaN 0.0000000 NA
msp_2459 NaN NaN 0.0000000 NA
msp_2460 NaN NaN 0.0000000 NA
msp_2461 NaN NaN 0.0000000 NA
msp_2462 1.0000000 1 -0.1111111 P2
msp_2463 1.0000000 1 -0.1111111 P2
msp_2464 1.0000000 1 -0.1111111 P2
msp_2465 NaN NaN 0.0000000 NA
msp_2466 NaN NaN 0.0000000 NA
msp_2467 1.0000000 1 -0.1111111 P2
msp_2468 NaN NaN 0.0000000 NA
msp_2469 NaN NaN 0.0000000 NA
msp_2470 NaN NaN 0.0000000 NA
msp_2471 NaN NaN 0.0000000 NA
msp_2472 NaN NaN 0.0000000 NA
msp_2473 NaN NaN 0.0000000 NA
msp_2474 1.0000000 1 0.1111111 P1
msp_2475 1.0000000 1 -0.1111111 P2
msp_2476 1.0000000 1 -0.1111111 P2
msp_2477 1.0000000 1 0.1111111 P1
msp_2478 1.0000000 1 0.1111111 P1
msp_2479 1.0000000 1 0.1111111 P1
msp_2480 1.0000000 1 0.1111111 P1
msp_2481 1.0000000 1 0.1111111 P1
msp_2482 NaN NaN 0.0000000 NA
msp_2483 1.0000000 1 0.1111111 P1
msp_2484 NaN NaN 0.0000000 NA
msp_2485 NaN NaN 0.0000000 NA
msp_2486 NaN NaN 0.0000000 NA
msp_2487 NaN NaN 0.0000000 NA
msp_2488 NaN NaN 0.0000000 NA
msp_2489 NaN NaN 0.0000000 NA
msp_2490 0.5049851 1 -0.3333333 P2
msp_2491 NaN NaN 0.0000000 NA
msp_2492 1.0000000 1 0.1111111 P1
msp_2493 NaN NaN 0.0000000 NA
msp_2494 0.5049851 1 -0.3333333 P2
msp_2495 1.0000000 1 -0.1111111 P2
msp_2496 NaN NaN 0.0000000 NA
msp_2497 NaN NaN 0.0000000 NA
msp_2498 NaN NaN 0.0000000 NA
msp_2499 1.0000000 1 0.1111111 P1
msp_2500 NaN NaN 0.0000000 NA
msp_2501 NaN NaN 0.0000000 NA
msp_2502 NaN NaN 0.0000000 NA
msp_2503 NaN NaN 0.0000000 NA
msp_2504 NaN NaN 0.0000000 NA
msp_2505 1.0000000 1 -0.1111111 P2
msp_2506 NaN NaN 0.0000000 NA
msp_2507 1.0000000 1 -0.1111111 P2
msp_2508 NaN NaN 0.0000000 NA
msp_2509 1.0000000 1 -0.1111111 P2
msp_2510 NaN NaN 0.0000000 NA
msp_2511 0.8247781 1 -0.2222222 P2
msp_2512 1.0000000 1 -0.1111111 P2
msp_2513 NaN NaN 0.0000000 NA
msp_2514 NaN NaN 0.0000000 NA
msp_2515 0.5049851 1 -0.3333333 P2
msp_2516 1.0000000 1 0.1111111 P1
msp_2517 NaN NaN 0.0000000 NA
msp_2518 NaN NaN 0.0000000 NA
msp_2519 NaN NaN 0.0000000 NA
msp_2520 1.0000000 1 -0.1111111 P2
msp_2521 NaN NaN 0.0000000 NA
msp_2522 NaN NaN 0.0000000 NA
msp_2523 1.0000000 1 -0.1111111 P2
msp_2524 NaN NaN 0.0000000 NA
msp_2525 NaN NaN 0.0000000 NA
msp_2526 NaN NaN 0.0000000 NA
msp_2527 NaN NaN 0.0000000 NA
msp_2528 NaN NaN 0.0000000 NA
msp_2529 NaN NaN 0.0000000 NA
msp_2530 0.5049851 1 -0.3333333 P2
msp_2531 0.5049851 1 0.3333333 P1
msp_2532 1.0000000 1 -0.1111111 P2
msp_2533 0.5049851 1 -0.3333333 P2
msp_2534 NaN NaN 0.0000000 NA
msp_2535 1.0000000 1 0.1111111 P1
msp_2536 1.0000000 1 -0.1111111 P2
msp_2537 NaN NaN 0.0000000 NA
msp_2538 NaN NaN 0.0000000 NA
msp_2539 NaN NaN 0.0000000 NA
msp_2540 0.6428348 1 -0.3333333 P2
msp_2541 1.0000000 1 -0.1111111 P2
msp_2542 NaN NaN 0.0000000 NA
msp_2543 NaN NaN 0.0000000 NA
msp_2544 1.0000000 1 0.1111111 P1
msp_2545 1.0000000 1 0.1111111 P1
msp_2546 NaN NaN 0.0000000 NA
msp_2547 0.5049851 1 0.3333333 P1
msp_2548 NaN NaN 0.0000000 NA
msp_2549 NaN NaN 0.0000000 NA
msp_2550 0.7000000 1 -0.3333333 P2
msp_2551 NaN NaN 0.0000000 NA
msp_2552 1.0000000 1 -0.1111111 P2
msp_2553 NaN NaN 0.0000000 NA
msp_2554 1.0000000 1 0.1111111 P1
msp_2555 NaN NaN 0.0000000 NA
msp_2556 NaN NaN 0.0000000 NA
msp_2557 NaN NaN 0.0000000 NA
msp_2558 NaN NaN 0.0000000 NA
msp_2559 NaN NaN 0.0000000 NA
msp_2560 NaN NaN 0.0000000 NA
msp_2561 NaN NaN 0.0000000 NA
msp_2562 NaN NaN 0.0000000 NA
msp_2563 1.0000000 1 -0.1111111 P2
msp_2564 0.8247781 1 0.2222222 P1
msp_2565 NaN NaN 0.0000000 NA
msp_2566 NaN NaN 0.0000000 NA
msp_2567 0.5049851 1 0.3333333 P1
msp_2568 NaN NaN 0.0000000 NA
msp_2569 0.8247781 1 0.2222222 P1
msp_2570 1.0000000 1 -0.1111111 P2
msp_2571 NaN NaN 0.0000000 NA
msp_2572 NaN NaN 0.0000000 NA
msp_2573 1.0000000 1 0.1111111 P1
msp_2574 NaN NaN 0.0000000 NA
msp_2575 NaN NaN 0.0000000 NA
msp_2576 NaN NaN 0.0000000 NA
msp_2577 NaN NaN 0.0000000 NA
msp_2578 NaN NaN 0.0000000 NA
msp_2579 NaN NaN 0.0000000 NA
msp_2580 NaN NaN 0.0000000 NA
msp_2581 1.0000000 1 0.0000000 NA
msp_2582 NaN NaN 0.0000000 NA
msp_2583 NaN NaN 0.0000000 NA
msp_2584 0.8247781 1 0.2222222 P1
msp_2585 NaN NaN 0.0000000 NA
msp_2586 NaN NaN 0.0000000 NA
msp_2587 0.5049851 1 0.3333333 P1
msp_2588 0.5065552 1 -0.4444444 P2
msp_2589 1.0000000 1 0.1111111 P1
msp_2590 NaN NaN 0.0000000 NA
msp_2591 NaN NaN 0.0000000 NA
msp_2592 1.0000000 1 0.1111111 P1
msp_2593 1.0000000 1 -0.1111111 P2
msp_2594 NaN NaN 0.0000000 NA
msp_2595 1.0000000 1 0.1111111 P1
msp_2596 1.0000000 1 -0.1111111 P2
msp_2597 1.0000000 1 -0.1111111 P2
msp_2598 NaN NaN 0.0000000 NA
msp_2599 NaN NaN 0.0000000 NA
msp_2600 NaN NaN 0.0000000 NA
msp_2601 NaN NaN 0.0000000 NA
msp_2602 NaN NaN 0.0000000 NA
msp_2603 NaN NaN 0.0000000 NA
msp_2604 NaN NaN 0.0000000 NA
msp_2605 1.0000000 1 -0.1111111 P2
msp_2606 NaN NaN 0.0000000 NA
msp_2607 NaN NaN 0.0000000 NA
msp_2608 NaN NaN 0.0000000 NA
msp_2609 NaN NaN 0.0000000 NA
msp_2610 1.0000000 1 -0.1111111 P2
msp_2611 1.0000000 1 -0.1111111 P2
msp_2612 NaN NaN 0.0000000 NA
msp_2613 NaN NaN 0.0000000 NA
msp_2614 NaN NaN 0.0000000 NA
msp_2615 NaN NaN 0.0000000 NA
msp_2616 NaN NaN 0.0000000 NA
msp_2617 NaN NaN 0.0000000 NA
msp_2618 NaN NaN 0.0000000 NA
msp_2619 1.0000000 1 0.0000000 NA
msp_2620 NaN NaN 0.0000000 NA
msp_2621 NaN NaN 0.0000000 NA
msp_2622 0.5049851 1 0.3333333 P1
msp_2623 1.0000000 1 -0.1111111 P2
msp_2624 NaN NaN 0.0000000 NA
msp_2625 0.2000000 1 0.7777778 P1
msp_2626 NaN NaN 0.0000000 NA
msp_2627 NaN NaN 0.0000000 NA
msp_2628 1.0000000 1 0.1111111 P1
msp_2629 NaN NaN 0.0000000 NA
msp_2630 NaN NaN 0.0000000 NA
msp_2631 NaN NaN 0.0000000 NA
msp_2632 NaN NaN 0.0000000 NA
msp_2633 NaN NaN 0.0000000 NA
msp_2634 NaN NaN 0.0000000 NA
msp_2635 NaN NaN 0.0000000 NA
msp_2636 NaN NaN 0.0000000 NA
msp_2637 NaN NaN 0.0000000 NA
msp_2638 1.0000000 1 -0.1111111 P2
msp_2639 0.6428348 1 -0.3333333 P2
msp_2640 1.0000000 1 0.1111111 P1
msp_2641 NaN NaN 0.0000000 NA
msp_2642 NaN NaN 0.0000000 NA
msp_2643 NaN NaN 0.0000000 NA
msp_2644 NaN NaN 0.0000000 NA
msp_2645 1.0000000 1 0.1111111 P1
msp_2646 1.0000000 1 -0.1111111 P2
msp_2647 1.0000000 1 0.1111111 P1
msp_2648 NaN NaN 0.0000000 NA
msp_2649 NaN NaN 0.0000000 NA
msp_2650 NaN NaN 0.0000000 NA
msp_2651 NaN NaN 0.0000000 NA
msp_2652 NaN NaN 0.0000000 NA
msp_2653 NaN NaN 0.0000000 NA
msp_2654 NaN NaN 0.0000000 NA
msp_2655 NaN NaN 0.0000000 NA
msp_2656 1.0000000 1 -0.1111111 P2
msp_2657 NaN NaN 0.0000000 NA
msp_2658 0.5065552 1 -0.4444444 P2
msp_2659 NaN NaN 0.0000000 NA
msp_2660 0.8247781 1 0.2222222 P1
msp_2661 NaN NaN 0.0000000 NA
msp_2662 NaN NaN 0.0000000 NA
msp_2663 NaN NaN 0.0000000 NA
msp_2664 NaN NaN 0.0000000 NA
msp_2665 0.5049851 1 -0.3333333 P2
msp_2666 1.0000000 1 -0.1111111 P2
msp_2667 NaN NaN 0.0000000 NA
msp_2668 0.5049851 1 -0.3333333 P2
msp_2669 0.5049851 1 -0.3333333 P2
msp_2670 NaN NaN 0.0000000 NA
msp_2671 1.0000000 1 0.1111111 P1
msp_2672 NaN NaN 0.0000000 NA
msp_2673 NaN NaN 0.0000000 NA
msp_2674 NaN NaN 0.0000000 NA
msp_2675 NaN NaN 0.0000000 NA
msp_2676 NaN NaN 0.0000000 NA
msp_2677 NaN NaN 0.0000000 NA
msp_2678 NaN NaN 0.0000000 NA
msp_2679 NaN NaN 0.0000000 NA
msp_2680 NaN NaN 0.0000000 NA
msp_2681 NaN NaN 0.0000000 NA
msp_2682 NaN NaN 0.0000000 NA
msp_2683 NaN NaN 0.0000000 NA
msp_2684 NaN NaN 0.0000000 NA
msp_2685 NaN NaN 0.0000000 NA
msp_2686 NaN NaN 0.0000000 NA
msp_2687 0.5049851 1 0.3333333 P1
msp_2688 NaN NaN 0.0000000 NA
msp_2689 NaN NaN 0.0000000 NA
msp_2690 NaN NaN 0.0000000 NA
msp_2691 NaN NaN 0.0000000 NA
msp_2692 NaN NaN 0.0000000 NA
msp_2693 NaN NaN 0.0000000 NA
msp_2694 NaN NaN 0.0000000 NA
msp_2695 NaN NaN 0.0000000 NA
msp_2696 NaN NaN 0.0000000 NA
msp_2697 0.8247781 1 0.2222222 P1
msp_2698 1.0000000 1 -0.1111111 P2
msp_2699 0.5049851 1 -0.3333333 P2
msp_2700 1.0000000 1 0.1111111 P1
msp_2701 NaN NaN 0.0000000 NA
msp_2702 NaN NaN 0.0000000 NA
msp_2703 NaN NaN 0.0000000 NA
msp_2704 NaN NaN 0.0000000 NA
msp_2705 NaN NaN 0.0000000 NA
msp_2706 NaN NaN 0.0000000 NA
msp_2707 NaN NaN 0.0000000 NA
msp_2708 NaN NaN 0.0000000 NA
msp_2709 NaN NaN 0.0000000 NA
msp_2710 NaN NaN 0.0000000 NA
msp_2711 NaN NaN 0.0000000 NA
msp_2712 NaN NaN 0.0000000 NA
msp_2713 NaN NaN 0.0000000 NA
msp_2714 NaN NaN 0.0000000 NA
msp_2715 NaN NaN 0.0000000 NA
msp_2716 NaN NaN 0.0000000 NA
msp_2717 NaN NaN 0.0000000 NA
msp_2718 NaN NaN 0.0000000 NA
msp_2719 1.0000000 1 0.1111111 P1
msp_2720 NaN NaN 0.0000000 NA
msp_2721 NaN NaN 0.0000000 NA
msp_2722 NaN NaN 0.0000000 NA
msp_2723 NaN NaN 0.0000000 NA
msp_2724 NaN NaN 0.0000000 NA
msp_2725 NaN NaN 0.0000000 NA
msp_2726 1.0000000 1 0.1111111 P1
msp_2727 NaN NaN 0.0000000 NA
msp_2728 NaN NaN 0.0000000 NA
msp_2729 NaN NaN 0.0000000 NA
msp_2730 1.0000000 1 0.1111111 P1
msp_2731 1.0000000 1 -0.1111111 P2
msp_2732 NaN NaN 0.0000000 NA
msp_2733 NaN NaN 0.0000000 NA
msp_2734 1.0000000 1 0.1111111 P1
msp_2735 NaN NaN 0.0000000 NA
msp_2736 NaN NaN 0.0000000 NA
msp_2737 1.0000000 1 -0.1111111 P2
msp_2738 1.0000000 1 0.1111111 P1
msp_2739 NaN NaN 0.0000000 NA
msp_2740 NaN NaN 0.0000000 NA
msp_2741 NaN NaN 0.0000000 NA
msp_2742 NaN NaN 0.0000000 NA
msp_2743 NaN NaN 0.0000000 NA
msp_2744 NaN NaN 0.0000000 NA
msp_2745 NaN NaN 0.0000000 NA
msp_2746 NaN NaN 0.0000000 NA
msp_2747 NaN NaN 0.0000000 NA
msp_2748 NaN NaN 0.0000000 NA
msp_2749 NaN NaN 0.0000000 NA
msp_2750 NaN NaN 0.0000000 NA
msp_2751 NaN NaN 0.0000000 NA
msp_2752 NaN NaN 0.0000000 NA
msp_2753 NaN NaN 0.0000000 NA
msp_2754 NaN NaN 0.0000000 NA
msp_2755 NaN NaN 0.0000000 NA
msp_2756 NaN NaN 0.0000000 NA
msp_2757 NaN NaN 0.0000000 NA
msp_2758 NaN NaN 0.0000000 NA
msp_2759 NaN NaN 0.0000000 NA
msp_2760 NaN NaN 0.0000000 NA
msp_2761 NaN NaN 0.0000000 NA
msp_2762 NaN NaN 0.0000000 NA
msp_2763 NaN NaN 0.0000000 NA
msp_2764 NaN NaN 0.0000000 NA
msp_2765 NaN NaN 0.0000000 NA
msp_2766 NaN NaN 0.0000000 NA
msp_2767 NaN NaN 0.0000000 NA
msp_2768 NaN NaN 0.0000000 NA
msp_2769 NaN NaN 0.0000000 NA
msp_2770 NaN NaN 0.0000000 NA
msp_2771 NaN NaN 0.0000000 NA
msp_2772 NaN NaN 0.0000000 NA
msp_2773 NaN NaN 0.0000000 NA
msp_2774 NaN NaN 0.0000000 NA
msp_2775 NaN NaN 0.0000000 NA
msp_2776 NaN NaN 0.0000000 NA
msp_2777 NaN NaN 0.0000000 NA
msp_2778 NaN NaN 0.0000000 NA
msp_2779 NaN NaN 0.0000000 NA
msp_2780 1.0000000 1 -0.1111111 P2
msp_2781 NaN NaN 0.0000000 NA
msp_2782 NaN NaN 0.0000000 NA
msp_2783 NaN NaN 0.0000000 NA
msp_2784 NaN NaN 0.0000000 NA
msp_2785 NaN NaN 0.0000000 NA
msp_2786 NaN NaN 0.0000000 NA
msp_2787 NaN NaN 0.0000000 NA
msp_2788 NaN NaN 0.0000000 NA
msp_2789 NaN NaN 0.0000000 NA
msp_2790 NaN NaN 0.0000000 NA
msp_2791 NaN NaN 0.0000000 NA
msp_2792 NaN NaN 0.0000000 NA
msp_2793 1.0000000 1 -0.1111111 P2
msp_2794 1.0000000 1 0.1111111 P1
msp_2795 1.0000000 1 0.1111111 P1
msp_2796 NaN NaN 0.0000000 NA
msp_2797 NaN NaN 0.0000000 NA
msp_2798 NaN NaN 0.0000000 NA
msp_2799 NaN NaN 0.0000000 NA
msp_2800 NaN NaN 0.0000000 NA
msp_2801 NaN NaN 0.0000000 NA
msp_2802 NaN NaN 0.0000000 NA
msp_2803 NaN NaN 0.0000000 NA
msp_2804 NaN NaN 0.0000000 NA
msp_2805 NaN NaN 0.0000000 NA
msp_2806 NaN NaN 0.0000000 NA
msp_2807 NaN NaN 0.0000000 NA
msp_2808 NaN NaN 0.0000000 NA
msp_2809 1.0000000 1 -0.1111111 P2
msp_2810 NaN NaN 0.0000000 NA
msp_2811 NaN NaN 0.0000000 NA
msp_2812 1.0000000 1 -0.1111111 P2
msp_2813 NaN NaN 0.0000000 NA
msp_2814 NaN NaN 0.0000000 NA
msp_2815 1.0000000 1 0.1111111 P1
msp_2816 NaN NaN 0.0000000 NA
msp_2817 NaN NaN 0.0000000 NA
msp_2818 NaN NaN 0.0000000 NA
msp_2819 NaN NaN 0.0000000 NA
msp_2820 NaN NaN 0.0000000 NA
msp_2821 NaN NaN 0.0000000 NA
msp_2822 NaN NaN 0.0000000 NA
msp_2823 NaN NaN 0.0000000 NA
msp_2824 0.5049851 1 0.3333333 P1
msp_2825 NaN NaN 0.0000000 NA
msp_2826 NaN NaN 0.0000000 NA
msp_2827 NaN NaN 0.0000000 NA
msp_2828 NaN NaN 0.0000000 NA
msp_2829 0.5065552 1 0.4444444 P1
msp_2830 NaN NaN 0.0000000 NA
msp_2831 NaN NaN 0.0000000 NA
msp_2832 NaN NaN 0.0000000 NA
msp_2833 NaN NaN 0.0000000 NA
msp_2834 NaN NaN 0.0000000 NA
msp_2835 NaN NaN 0.0000000 NA
msp_2836 NaN NaN 0.0000000 NA
msp_2837 0.7000000 1 0.3333333 P1
msp_2838 NaN NaN 0.0000000 NA
msp_2839 NaN NaN 0.0000000 NA
msp_2840 NaN NaN 0.0000000 NA
msp_2841 NaN NaN 0.0000000 NA
msp_2842 NaN NaN 0.0000000 NA
msp_2843 NaN NaN 0.0000000 NA
msp_2844 NaN NaN 0.0000000 NA
msp_2845 NaN NaN 0.0000000 NA
msp_2846 NaN NaN 0.0000000 NA
msp_2847 NaN NaN 0.0000000 NA
msp_2848 NaN NaN 0.0000000 NA
msp_2849 NaN NaN 0.0000000 NA
msp_2850 NaN NaN 0.0000000 NA
msp_2851 NaN NaN 0.0000000 NA
msp_2852 NaN NaN 0.0000000 NA
msp_2853 NaN NaN 0.0000000 NA
msp_2854 0.8247781 1 0.2222222 P1
msp_2855 NaN NaN 0.0000000 NA
msp_2856 NaN NaN 0.0000000 NA
msp_2857 NaN NaN 0.0000000 NA
msp_2858 NaN NaN 0.0000000 NA
msp_2859 NaN NaN 0.0000000 NA
msp_2860 NaN NaN 0.0000000 NA
msp_2861 NaN NaN 0.0000000 NA
msp_2862 NaN NaN 0.0000000 NA
msp_2863 NaN NaN 0.0000000 NA
msp_2864 NaN NaN 0.0000000 NA
msp_2865 NaN NaN 0.0000000 NA
msp_2866 NaN NaN 0.0000000 NA
msp_2867 NaN NaN 0.0000000 NA
msp_2868 NaN NaN 0.0000000 NA
msp_2869 NaN NaN 0.0000000 NA
msp_2870 NaN NaN 0.0000000 NA
msp_2871 NaN NaN 0.0000000 NA
msp_2872 NaN NaN 0.0000000 NA
msp_2873 NaN NaN 0.0000000 NA
msp_2874 NaN NaN 0.0000000 NA
msp_2875 1.0000000 1 0.1111111 P1
msp_2876 NaN NaN 0.0000000 NA
msp_2877 NaN NaN 0.0000000 NA
msp_2878 NaN NaN 0.0000000 NA
msp_2879 NaN NaN 0.0000000 NA
msp_2880 NaN NaN 0.0000000 NA
msp_2881 NaN NaN 0.0000000 NA
msp_2882 1.0000000 1 -0.1111111 P2
msp_2883 NaN NaN 0.0000000 NA
msp_2884 NaN NaN 0.0000000 NA
msp_2885 NaN NaN 0.0000000 NA
msp_2886 0.4000000 1 -0.5555556 P2
msp_2887 0.4000000 1 -0.5555556 P2
msp_2888 0.5065552 1 -0.4444444 P2
msp_2889 NaN NaN 0.0000000 NA
msp_2890 NaN NaN 0.0000000 NA
msp_2891 NaN NaN 0.0000000 NA
msp_2892 0.7000000 1 0.3333333 P1
msp_2893 1.0000000 1 -0.1111111 P2
msp_2894 1.0000000 1 0.1111111 P1
msp_2895 1.0000000 1 -0.1111111 P2
msp_2896 NaN NaN 0.0000000 NA
msp_2897 NaN NaN 0.0000000 NA
msp_2898 NaN NaN 0.0000000 NA
msp_2899 NaN NaN 0.0000000 NA
msp_2900 NaN NaN 0.0000000 NA
msp_2901 NaN NaN 0.0000000 NA
msp_2902 NaN NaN 0.0000000 NA
msp_2903 NaN NaN 0.0000000 NA
msp_2904 0.4000000 1 -0.5555556 P2
msp_2905 0.5049851 1 0.3333333 P1
msp_2906 0.6428348 1 0.3333333 P1
msp_2907 NaN NaN 0.0000000 NA
msp_2908 1.0000000 1 -0.1111111 P2
msp_2909 1.0000000 1 0.0000000 NA
msp_2910 NaN NaN 0.0000000 NA
msp_2911 0.6428348 1 0.3333333 P1
msp_2912 1.0000000 1 -0.1111111 P2
msp_2913 NaN NaN 0.0000000 NA
msp_2914 0.2000000 1 0.7777778 P1
msp_2915 NaN NaN 0.0000000 NA
msp_2916 1.0000000 1 0.0000000 NA
msp_2917 NaN NaN 0.0000000 NA
msp_2918 0.5049851 1 -0.3333333 P2
msp_2919 0.8247781 1 0.2222222 P1
msp_2920 NaN NaN 0.0000000 NA
msp_2921 NaN NaN 0.0000000 NA
msp_2922 1.0000000 1 0.0000000 NA
msp_2923 NaN NaN 0.0000000 NA
msp_2924 NaN NaN 0.0000000 NA
msp_2925 1.0000000 1 0.1111111 P1
msp_2926 1.0000000 1 0.1111111 P1
msp_2927 1.0000000 1 0.1111111 P1
msp_2928 NaN NaN 0.0000000 NA
msp_2929 1.0000000 1 -0.1111111 P2
msp_2930 NaN NaN 0.0000000 NA
msp_2931 NaN NaN 0.0000000 NA
msp_2932 NaN NaN 0.0000000 NA
msp_2933 NaN NaN 0.0000000 NA
msp_2934 1.0000000 1 -0.1111111 P2
msp_2935 0.4000000 1 0.5555556 P1
msp_2936 NaN NaN 0.0000000 NA
msp_2937 1.0000000 1 0.0000000 NA
msp_2938 1.0000000 1 -0.1111111 P2
msp_2939 NaN NaN 0.0000000 NA
msp_2940 NaN NaN 0.0000000 NA
msp_2941 NaN NaN 0.0000000 NA
msp_2942 1.0000000 1 0.0000000 NA
msp_2943 0.7000000 1 0.3333333 P1
msp_2944 1.0000000 1 -0.1111111 P2
msp_2945 NaN NaN 0.0000000 NA
msp_2946 1.0000000 1 0.0000000 NA
msp_2947 1.0000000 1 0.1111111 P1
msp_2948 NaN NaN 0.0000000 NA
msp_2949 NaN NaN 0.0000000 NA
msp_2950 0.8247781 1 -0.2222222 P2
msp_2951 NaN NaN 0.0000000 NA
msp_2952 NaN NaN 0.0000000 NA
msp_2953 NaN NaN 0.0000000 NA
msp_2954 NaN NaN 0.0000000 NA
msp_2955 NaN NaN 0.0000000 NA
msp_2956 NaN NaN 0.0000000 NA
msp_2957 NaN NaN 0.0000000 NA
msp_2958 NaN NaN 0.0000000 NA
msp_2959 NaN NaN 0.0000000 NA
msp_2960 NaN NaN 0.0000000 NA
msp_2961 NaN NaN 0.0000000 NA
msp_2962 NaN NaN 0.0000000 NA

No significant differences. Trends observed for two MSP species (p<0.1).